diff --git a/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.h b/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.h
new file mode 100644
index 0000000000000000000000000000000000000000..0047c9cf8f3f6eabdb45229c012c7169be315118
--- /dev/null
+++ b/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.h
@@ -0,0 +1,153 @@
+/*=========================================================================
+
+  Program:   ORFEO Toolbox
+  Language:  C++
+  Date:      $Date$
+  Version:   $Revision$
+
+
+  Copyright (c) Centre National d'Etudes Spatiales. All rights reserved.
+  See OTBCopyright.txt for details.
+
+
+     This software is distributed WITHOUT ANY WARRANTY; without even
+     the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR
+     PURPOSE.  See the above copyright notices for more information.
+
+=========================================================================*/
+#ifndef __otbOGRDataSourceToLabelImageFilter_h
+#define __otbOGRDataSourceToLabelImageFilter_h
+
+#include "itkImageToImageFilter.h"
+#include "itkImageSource.h"
+#include "otbMacro.h"
+
+
+#include "gdal.h"
+#include "gdal_alg.h"
+#include "otbOGRDataSourceWrapper.h"
+
+namespace otb {
+
+/** \class OGRDataSourceToLabelImageFilter
+ *  \brief Burn geometries from the specified VectorData into raster
+ *
+ *  This class handles burning several input \c OGRDataSource into the
+ *  output raster.  The burn values are extracted from a field set by
+ *  the user (default field is DN).
+ *
+ *  Setting the output raster informations can be done in two ways by:
+ *    - Setting the Origin/Size/Spacing of the output image
+ *    - Using an existing image as support via SetOutputParametersFromImage(ImageBase)
+ *
+ *
+ */
+template < class TOutputImage >
+class  ITK_EXPORT OGRDataSourceToLabelImageFilter :
+    public itk::ImageSource<TOutputImage>
+{
+public:
+  /** Standard class typedefs */
+  typedef OGRDataSourceToLabelImageFilter       Self;
+  typedef itk::ImageSource<TOutputImage>        Superclass;
+  typedef itk::SmartPointer< Self >             Pointer;
+  typedef itk::SmartPointer<const Self>         ConstPointer;
+  
+  /** Run-time type information (and related methods). */
+  itkTypeMacro(OGRDataSourceToLabelImageFilter, itk::ImageSource);
+  
+  /** Method for creation through the object factory. */
+  itkNewMacro(Self);
+
+  typedef TOutputImage                                OutputImageType;
+  typedef typename OutputImageType::Pointer           OutputImagePointer;
+  typedef typename OutputImageType::SizeType          OutputSizeType;
+  typedef typename OutputImageType::IndexType         OutputIndexType;
+  typedef typename OutputImageType::SpacingType       OutputSpacingType;
+  typedef typename OutputImageType::PointType         OutputOriginType;
+  typedef typename OutputImageType::RegionType        OutputImageRegionType;
+  typedef typename OutputImageType::PixelType         OutputImagePixelType;
+  typedef typename OutputImageType::InternalPixelType OutputImageInternalPixelType;
+
+  /** VectorData typedefs*/
+  typedef ogr::DataSource                            OGRDataSourceType;
+  typedef typename OGRDataSourceType::Pointer        OGRDataSourcePointerType;
+  typedef ogr::Layer                                 OGRLayerType;
+
+  typedef itk::ImageBase<OutputImageType::ImageDimension>      ImageBaseType;
+
+  /** Get Nth input \c OGRDataSource */
+  const OGRDataSourceType*  GetInput(unsigned int idx);
+  
+  /** Method for adding a \c OGRDataSource to rasterize  */
+  virtual void AddOGRDataSource(const OGRDataSourceType* ds);
+  
+  /** Set the size of the output image. */
+  itkSetMacro(OutputSize, OutputSizeType);
+
+  /** Get the size of the output image. */
+  itkGetConstReferenceMacro(OutputSize, OutputSizeType);
+
+  /** Set the origin of the output image.
+   * \sa GetOrigin()
+   */
+  itkSetMacro(OutputOrigin, OutputOriginType);
+  virtual void SetOutputOrigin(const double origin[2]);
+  virtual void SetOutputOrigin(const float origin[2]);
+
+  itkGetConstReferenceMacro(OutputOrigin, OutputOriginType);
+
+  /** Set the spacing (size of a pixel) of the output image.
+  * \sa GetSpacing()
+  */
+  virtual void SetOutputSpacing(const OutputSpacingType& spacing);
+  virtual void SetOutputSpacing(const double spacing[2]);
+  virtual void SetOutputSpacing(const float spacing[2]);
+
+  /** Set/Get Output Projection Ref */
+  itkSetStringMacro(OutputProjectionRef);
+  itkGetStringMacro(OutputProjectionRef);
+
+  /** Set the attribute field on the \c OGRFeature to be used as burn value in the output image*/
+  itkSetStringMacro(BurnAttribute);
+  itkGetStringMacro(BurnAttribute);
+
+  /** Useful to set the output parameters from an existing image*/
+  void SetOutputParametersFromImage(const ImageBaseType * image);
+
+protected:
+  virtual void GenerateData();
+
+  OGRDataSourceToLabelImageFilter();
+  virtual ~OGRDataSourceToLabelImageFilter() {}
+
+  virtual void GenerateOutputInformation();
+  
+  void PrintSelf(std::ostream& os, itk::Indent indent) const;
+
+private:
+  OGRDataSourceToLabelImageFilter(const Self&); //purposely not implemented
+  void operator=(const Self&); //purposely not implemented
+
+  std::vector< OGRLayerH >    m_SrcDataSetLayers;
+  std::vector<int>            m_BandsToBurn;
+  
+  // Field used to extract the burn value
+  std::string                   m_BurnAttribute;
+
+  // Output params
+  std::string                   m_OutputProjectionRef;
+  OutputSpacingType             m_OutputSpacing;
+  OutputOriginType              m_OutputOrigin;
+  OutputSizeType                m_OutputSize;
+  OutputIndexType               m_OutputStartIndex;
+}; // end of class VectorDataToLabelImageFilter
+
+} // end of namespace otb
+
+
+#ifndef  OTB_MANUAL_INSTANTIATION
+#include "otbOGRDataSourceToLabelImageFilter.txx"
+#endif
+
+#endif
diff --git a/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.txx b/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.txx
new file mode 100644
index 0000000000000000000000000000000000000000..e5a353076b92b305e9b07e82f12bbd28dedfda4d
--- /dev/null
+++ b/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.txx
@@ -0,0 +1,243 @@
+/*=========================================================================
+
+  Program:   ORFEO Toolbox
+  Language:  C++
+  Date:      $Date$
+  Version:   $Revision$
+
+
+  Copyright (c) Centre National d'Etudes Spatiales. All rights reserved.
+  See OTBCopyright.txt for details.
+
+
+     This software is distributed WITHOUT ANY WARRANTY; without even
+     the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR
+     PURPOSE.  See the above copyright notices for more information.
+
+=========================================================================*/
+
+#include "otbOGRDataSourceToLabelImageFilter.h"
+#include "otbOGRIOHelper.h"
+#include "otbGdalDataTypeBridge.h"
+#include "otbMacro.h"
+
+#include "gdal_alg.h"
+
+namespace otb
+{
+template< class TOutputImage>
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::OGRDataSourceToLabelImageFilter() : m_BurnAttribute("DN")
+{
+  this->SetNumberOfRequiredInputs(1);
+
+  // Output parameters initialization
+  m_OutputSpacing.Fill(1.0);
+  m_OutputSize.Fill(0);
+  m_OutputStartIndex.Fill(0);
+  m_BandsToBurn.clear();
+  m_BandsToBurn.push_back(1);
+  
+}
+
+template< class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::AddOGRDataSource(const OGRDataSourceType* ds)
+{
+  this->itk::ProcessObject::PushBackInput( ds );
+}
+
+template < class TOutputImage>
+const typename OGRDataSourceToLabelImageFilter<TOutputImage>::OGRDataSourceType *
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::GetInput(unsigned int idx)
+{
+  return static_cast<const OGRDataSourceType *>
+           (this->itk::ProcessObject::GetInput(idx));
+}
+
+template < class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::SetOutputSpacing(const OutputSpacingType& spacing)
+{
+  if (this->m_OutputSpacing != spacing)
+    {
+    this->m_OutputSpacing = spacing;
+    this->Modified();
+    }
+}
+
+template < class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::SetOutputSpacing(const double spacing[2])
+{
+  OutputSpacingType s(spacing);
+  this->SetOutputSpacing(s);
+}
+
+template < class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::SetOutputSpacing(const float spacing[2])
+{
+  itk::Vector<float, 2> sf(spacing);
+  OutputSpacingType s;
+  s.CastFrom(sf);
+  this->SetOutputSpacing(s);
+}
+
+template < class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::SetOutputOrigin(const double origin[2])
+{
+  OutputOriginType p(origin);
+  this->SetOutputOrigin(p);
+}
+
+template < class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::SetOutputOrigin(const float origin[2])
+{
+  itk::Point<float, 2> of(origin);
+  OutputOriginType p;
+  p.CastFrom(of);
+  this->SetOutputOrigin(p);
+}
+
+template < class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::SetOutputParametersFromImage(const ImageBaseType * image)
+{
+  const OutputImageType * src = dynamic_cast<const OutputImageType*>(image);
+  
+  this->SetOutputOrigin ( src->GetOrigin() );
+  this->SetOutputSpacing ( src->GetSpacing() );
+  //this->SetOutputStartIndex ( src->GetLargestPossibleRegion().GetIndex() );
+  this->SetOutputSize ( src->GetLargestPossibleRegion().GetSize() );
+  this->SetOutputProjectionRef(src->GetProjectionRef());
+  //this->SetOutputKeywordList(src->GetImageKeywordlist());
+}
+
+template< class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::GenerateOutputInformation()
+{
+  // get pointer to the output
+  OutputImagePointer outputPtr = this->GetOutput();
+  if (!outputPtr)
+    {
+    return;
+    }
+
+  // Set the size of the output region
+  typename TOutputImage::RegionType outputLargestPossibleRegion;
+  outputLargestPossibleRegion.SetSize(m_OutputSize);
+  //outputLargestPossibleRegion.SetIndex(m_OutputStartIndex);
+  outputPtr->SetLargestPossibleRegion(outputLargestPossibleRegion);
+
+  // Set spacing and origin
+  outputPtr->SetSpacing(m_OutputSpacing);
+  outputPtr->SetOrigin(m_OutputOrigin);
+
+  itk::MetaDataDictionary& dict = outputPtr->GetMetaDataDictionary();
+  itk::EncapsulateMetaData<std::string> (dict, MetaDataKey::ProjectionRefKey,
+                                         static_cast<std::string>(this->GetOutputProjectionRef()));
+  
+  // Generate the OGRLayers from the input OGRDataSource
+  for (unsigned int idx = 0; idx < this->GetNumberOfInputs(); ++idx)
+    {
+    OGRDataSourcePointerType ogrDS = dynamic_cast<OGRDataSourceType*>(this->itk::ProcessObject::GetInput(idx));
+    const unsigned int nbLayers = ogrDS->GetLayersCount();
+
+    for (unsigned int layer = 0; layer < nbLayers; ++layer)
+      {
+         m_SrcDataSetLayers.push_back( &(ogrDS->GetLayer(layer).ogr()) );
+      }
+    }
+}
+
+template< class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>::GenerateData()
+{
+  // Call Superclass GenerateData
+  this->AllocateOutputs();
+  
+  // Get the buffered region
+  OutputImageRegionType bufferedRegion = this->GetOutput()->GetBufferedRegion();
+
+  // nb bands
+  const unsigned int & nbBands =  this->GetOutput()->GetNumberOfComponentsPerPixel();
+
+  // register drivers
+  GDALAllRegister();
+  
+  std::ostringstream stream;
+  stream << "MEM:::"
+         <<  "DATAPOINTER=" << (unsigned long)(this->GetOutput()->GetBufferPointer()) << ","
+         <<  "PIXELS=" << bufferedRegion.GetSize()[0] << ","
+         <<  "LINES=" << bufferedRegion.GetSize()[1]<< ","
+         <<  "BANDS=" << nbBands << ","
+         <<  "DATATYPE=" << GDALGetDataTypeName(GdalDataTypeBridge::GetGDALDataType<OutputImageInternalPixelType>()) << ","
+         <<  "PIXELOFFSET=" << sizeof(OutputImageInternalPixelType) *  nbBands << ","
+         <<  "LINEOFFSET=" << sizeof(OutputImageInternalPixelType)*nbBands*bufferedRegion.GetSize()[0] << ","
+         <<  "BANDOFFSET=" << sizeof(OutputImageInternalPixelType);
+  
+  GDALDatasetH dataset = GDALOpen(stream.str().c_str(), GA_Update);
+
+  // Add the projection ref to the dataset
+  GDALSetProjection (dataset, this->GetOutput()->GetProjectionRef().c_str());
+
+  // add the geoTransform to the dataset
+  itk::VariableLengthVector<double> geoTransform(6);
+
+  // Reporting origin and spacing of the buffered region
+  // the spacing is unchanged, the origin is relative to the buffered region
+  OutputIndexType  bufferIndexOrigin = bufferedRegion.GetIndex();
+  OutputOriginType bufferOrigin;
+  this->GetOutput()->TransformIndexToPhysicalPoint(bufferIndexOrigin, bufferOrigin);
+  geoTransform[0] = bufferOrigin[0];
+  geoTransform[3] = bufferOrigin[1];
+  geoTransform[1] = this->GetOutput()->GetSpacing()[0];
+  geoTransform[5] = this->GetOutput()->GetSpacing()[1];
+
+  // FIXME: Here component 1 and 4 should be replaced by the orientation parameters
+  geoTransform[2] = 0.;
+  geoTransform[4] = 0.;
+  GDALSetGeoTransform(dataset,const_cast<double*>(geoTransform.GetDataPointer()));
+
+  // Burn the geometries into the dataset
+   if (dataset != NULL)
+     {
+     std::vector<std::string> options;
+     options.push_back("ATTRIBUTE="+m_BurnAttribute);
+
+     GDALRasterizeLayers( dataset, nbBands,
+                          &m_BandsToBurn[0],
+                          m_SrcDataSetLayers.size(),
+                          &(m_SrcDataSetLayers[0]),
+                          NULL, NULL, NULL,
+                          ogr::StringListConverter(options).to_ogr(),
+                          NULL, NULL );
+     // release the dataset
+     GDALClose( dataset );
+     }
+}
+
+template< class TOutputImage>
+void
+OGRDataSourceToLabelImageFilter<TOutputImage>
+::PrintSelf(std::ostream& os, itk::Indent indent) const
+{
+  Superclass::PrintSelf(os, indent);
+}
+
+} // end namespace otb
+
diff --git a/Testing/Code/BasicFilters/CMakeLists.txt b/Testing/Code/BasicFilters/CMakeLists.txt
index 11a9863d6a0ff0fe9dc6e4ce96727faa5114bdd9..1c4d93b341f7cf84fb4ff1c69bdfae9f8ef5284a 100644
--- a/Testing/Code/BasicFilters/CMakeLists.txt
+++ b/Testing/Code/BasicFilters/CMakeLists.txt
@@ -2821,6 +2821,21 @@ ADD_TEST(bfTvVectorDataToLabelImageFilterSHP ${BASICFILTERS_TESTS15}
   ${TEMP}/bfTvVectorDataToLabelImageFilter_Output.tif
 )
 
+# ---------------------    otbOGRDataSourceToLabelImageFilter---------------------
+ADD_TEST(bfTuOGRDataSourceToLabelImageFilterNew ${BASICFILTERS_TESTS15}
+  otbOGRDataSourceToLabelImageFilterNew
+)
+
+ADD_TEST(bfTvOGRDataSourceToLabelImageFilterSHP ${BASICFILTERS_TESTS15}
+  --compare-image 0.0
+  ${INPUTDATA}/QB_Toulouse_ortho_labelImage.tif
+  ${TEMP}/bfTvOGRDataSourceToLabelImageFilter_Output.tif
+  otbOGRDataSourceToLabelImageFilter
+  ${INPUTDATA}/QB_Toulouse_ortho_labelImage.tif
+  ${INPUTDATA}/QB_Toulouse_ortho.shp
+  ${TEMP}/bfTvOGRDataSourceToLabelImageFilter_Output.tif
+)
+
 # ---------------------    otbPolygonizationRasterizationTest  ---------------------
 # bijectivity tests
 ADD_TEST(bfTvPolygonizationRasterization_UTM ${BASICFILTERS_TESTS15}
@@ -3156,6 +3171,7 @@ otbClampVectorImageFilter.cxx
 otbClampImageFilter.cxx
 otbVectorDataRasterizeFilter.cxx
 otbVectorDataToLabelImageFilter.cxx
+otbOGRDataSourceToLabelImageFilter.cxx
 otbPolygonizationRasterizationTest.cxx
 otbTileImageFilter.cxx
 )
diff --git a/Testing/Code/BasicFilters/otbBasicFiltersTests15.cxx b/Testing/Code/BasicFilters/otbBasicFiltersTests15.cxx
index e21dbe0062bb91e59b4624bcf193c85be7c5fe7d..ef350b31337ee3ddd4c7e8bb3b7fd4c4372e7124 100644
--- a/Testing/Code/BasicFilters/otbBasicFiltersTests15.cxx
+++ b/Testing/Code/BasicFilters/otbBasicFiltersTests15.cxx
@@ -47,6 +47,8 @@ void RegisterTests()
   REGISTER_TEST(otbVectorDataRasterizeFilter);
   REGISTER_TEST(otbVectorDataToLabelImageFilterNew);
   REGISTER_TEST(otbVectorDataToLabelImageFilter);
+  REGISTER_TEST(otbOGRDataSourceToLabelImageFilterNew);
+  REGISTER_TEST(otbOGRDataSourceToLabelImageFilter);
   REGISTER_TEST(otbPolygonizationRasterizationTest);
   REGISTER_TEST(otbTileImageFilterNew);
   REGISTER_TEST(otbTileImageFilter);
diff --git a/Testing/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.cxx b/Testing/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.cxx
new file mode 100644
index 0000000000000000000000000000000000000000..8a2edaa4592360719680edcdd2e7c193d1f3c30d
--- /dev/null
+++ b/Testing/Code/BasicFilters/otbOGRDataSourceToLabelImageFilter.cxx
@@ -0,0 +1,65 @@
+/*=========================================================================
+
+  Program:   ORFEO Toolbox
+  Language:  C++
+  Date:      $Date$
+  Version:   $Revision$
+
+
+  Copyright (c) Centre National d'Etudes Spatiales. All rights reserved.
+  See OTBCopyright.txt for details.
+
+  Copyright (c) Institut Telecom; Telecom Bretagne. All rights reserved.
+  See ITCopyright.txt for details.
+
+     This software is distributed WITHOUT ANY WARRANTY; without even
+     the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR
+     PURPOSE.  See the above copyright notices for more information.
+
+=========================================================================*/
+#include "otbImage.h"
+#include "otbImageFileReader.h"
+#include "otbStreamingImageFileWriter.h"
+
+#include "otbOGRDataSourceWrapper.h"
+
+#include "otbOGRDataSourceToLabelImageFilter.h"
+#include "otbStandardOneLineFilterWatcher.h"
+
+typedef otb::Image<unsigned int, 2>                           ImageType;
+typedef otb::ImageFileReader<ImageType>                       ReaderType;
+
+typedef otb::StreamingImageFileWriter<ImageType>              WriterType;
+typedef otb::OGRDataSourceToLabelImageFilter<ImageType>       RasterizationFilterType;
+
+int otbOGRDataSourceToLabelImageFilterNew(int argc, char* argv[])
+{
+  RasterizationFilterType::Pointer  rasterization = RasterizationFilterType::New();
+  return EXIT_SUCCESS;
+}
+
+int otbOGRDataSourceToLabelImageFilter(int argc, char* argv[])
+{
+  
+  ReaderType::Pointer reader = ReaderType::New();
+  reader->SetFileName(argv[1]);
+  reader->UpdateOutputInformation();
+
+  otb::ogr::DataSource::Pointer ogrDS = otb::ogr::DataSource::New(argv[2], otb::ogr::DataSource::Modes::write);
+  
+  // rasterize
+  RasterizationFilterType::Pointer  rasterization = RasterizationFilterType::New();
+  rasterization->AddOGRDataSource(ogrDS);
+  rasterization->SetOutputParametersFromImage(reader->GetOutput());
+  rasterization->SetBurnAttribute("DN");
+
+  /*otb::StandardOneLineFilterWatcher * watch = new otb::StandardOneLineFilterWatcher(rasterization.GetPointer(),
+                                                                          "rasterization");*/
+
+  WriterType::Pointer writer  = WriterType::New();
+  writer->SetFileName(argv[3]);
+  writer->SetInput(rasterization->GetOutput());
+  writer->Update();
+
+return EXIT_SUCCESS;
+}