diff --git a/Applications/FeatureExtraction/otbBinaryMorphologicalOperation.cxx b/Applications/FeatureExtraction/otbBinaryMorphologicalOperation.cxx
index d453b699a4bfac2148040b7167b67d59ed11f495..bc41a1964d5432cc33138924809a63940632a9d0 100644
--- a/Applications/FeatureExtraction/otbBinaryMorphologicalOperation.cxx
+++ b/Applications/FeatureExtraction/otbBinaryMorphologicalOperation.cxx
@@ -22,8 +22,8 @@
 #include "itkBinaryBallStructuringElement.h"
 #include "itkBinaryCrossStructuringElement.h"
 
-#include "itkBinaryDilateImageFilter.h"
-#include "itkBinaryErodeImageFilter.h"
+#include "otbBinaryDilateImageFilter.h"
+#include "otbBinaryErodeImageFilter.h"
 #include "itkBinaryMorphologicalOpeningImageFilter.h"
 #include "itkBinaryMorphologicalClosingImageFilter.h"
 
diff --git a/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryDilateImageFilter.h b/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryDilateImageFilter.h
new file mode 100644
index 0000000000000000000000000000000000000000..89075791a4c572bb32088d4dbe0ade26c0ebe797
--- /dev/null
+++ b/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryDilateImageFilter.h
@@ -0,0 +1,144 @@
+/*=========================================================================
+
+  Program:   Insight Segmentation & Registration Toolkit
+  Module:    $RCSfile: itkWatershedBoundaryResolver.h,v $
+  Language:  C++
+  Date:      $Date: 2009-04-23 03:53:37 $
+  Version:   $Revision: 1.12 $
+
+  Copyright (c) Insight Software Consortium. All rights reserved.
+  See ITKCopyright.txt or http://www.itk.org/HTML/Copyright.htm 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 __otbBinaryDilateImageFilter_h
+#define __otbBinaryDilateImageFilter_h
+
+#include <vector>
+#include <queue>
+#include "itkBinaryMorphologyImageFilter.h"
+#include "itkConstNeighborhoodIterator.h"
+
+namespace otb
+{
+/**
+ * \class BinaryDilateImageFilter
+ * \brief Fast binary dilation
+ *
+ * BinaryDilateImageFilter is a binary dilation
+ * morphologic operation. This implementation is based on the papers:
+ *
+ * L.Vincent "Morphological transformations of binary images with
+ * arbitrary structuring elements", and
+ *
+ * N.Nikopoulos et al. "An efficient algorithm for 3d binary
+ * morphological transformations with 3d structuring elements
+ * for arbitrary size and shape". IEEE Transactions on Image
+ * Processing. Vol. 9. No. 3. 2000. pp. 283-286.
+ *
+ * Gray scale images can be processed as binary images by selecting a
+ * "DilateValue".  Pixel values matching the dilate value are
+ * considered the "foreground" and all other pixels are
+ * "background". This is useful in processing segmented images where
+ * all pixels in segment #1 have value 1 and pixels in segment #2 have
+ * value 2, etc. A particular "segment number" can be processed.
+ * DilateValue defaults to the maximum possible value of the
+ * PixelType.
+ *
+ * The structuring element is assumed to be composed of binary values
+ * (zero or one). Only elements of the structuring element having
+ * values > 0 are candidates for affecting the center pixel.  A
+ * reasonable choice of structuring element is
+ * itk::BinaryBallStructuringElement.
+ *
+ * \sa ImageToImageFilter BinaryErodeImageFilter BinaryMorphologyImageFilter
+ * \ingroup ITKBinaryMathematicalMorphology
+ *
+ * \wiki
+ * \wikiexample{Morphology/BinaryDilateImageFilter,Dilate a binary image}
+ * \endwiki
+ */
+template< class TInputImage, class TOutputImage, class TKernel >
+class ITK_EXPORT BinaryDilateImageFilter:
+    public itk::BinaryMorphologyImageFilter< TInputImage, TOutputImage, TKernel >
+{
+public:
+  /** Extract dimension from input and output image. */
+  itkStaticConstMacro(InputImageDimension, unsigned int,
+                      TInputImage::ImageDimension);
+  itkStaticConstMacro(OutputImageDimension, unsigned int,
+                      TOutputImage::ImageDimension);
+
+  /** Extract the dimension of the kernel */
+  itkStaticConstMacro(KernelDimension, unsigned int,
+                      TKernel::NeighborhoodDimension);
+
+  /** Convenient typedefs for simplifying declarations. */
+  typedef TInputImage  InputImageType;
+  typedef TOutputImage OutputImageType;
+  typedef TKernel      KernelType;
+
+  /** Standard class typedefs. */
+  typedef BinaryDilateImageFilter Self;
+  typedef itk::BinaryMorphologyImageFilter< InputImageType, OutputImageType,
+                                       KernelType > Superclass;
+
+  typedef itk::SmartPointer< Self >       Pointer;
+  typedef itk::SmartPointer< const Self > ConstPointer;
+
+  /** Method for creation through the object factory. */
+  itkNewMacro(Self);
+
+  /** Run-time type information (and related methods). */
+  itkTypeMacro(BinaryDilateImageFilter, BinaryMorphologyImageFilter);
+
+  /** Kernel (structuring element) iterator. */
+  typedef typename KernelType::ConstIterator KernelIteratorType;
+
+  /** Image typedef support. */
+  typedef typename InputImageType::PixelType                 InputPixelType;
+  typedef typename OutputImageType::PixelType                OutputPixelType;
+  typedef typename itk::NumericTraits< InputPixelType >::RealType InputRealType;
+  typedef typename InputImageType::OffsetType                OffsetType;
+  typedef typename InputImageType::IndexType                 IndexType;
+
+  typedef typename InputImageType::RegionType  InputImageRegionType;
+  typedef typename OutputImageType::RegionType OutputImageRegionType;
+  typedef typename InputImageType::SizeType    InputSizeType;
+
+  /** Set the value in the image to consider as "foreground". Defaults to
+   * maximum value of PixelType. This is an alias to the
+   * ForegroundValue in the superclass. */
+  void SetDilateValue(const InputPixelType & value)
+  { this->SetForegroundValue(value); }
+
+  /** Get the value in the image considered as "foreground". Defaults to
+   * maximum value of PixelType. This is an alias to the
+   * ForegroundValue in the superclass. */
+  InputPixelType GetDilateValue() const
+  { return this->GetForegroundValue(); }
+
+protected:
+  BinaryDilateImageFilter();
+  virtual ~BinaryDilateImageFilter(){}
+  void PrintSelf(std::ostream & os, itk::Indent indent) const;
+
+  void GenerateData();
+
+  // type inherited from the superclass
+  typedef typename Superclass::NeighborIndexContainer NeighborIndexContainer;
+
+private:
+  BinaryDilateImageFilter(const Self &); //purposely not implemented
+  void operator=(const Self &);          //purposely not implemented
+};
+} // end namespace itk
+
+#ifndef ITK_MANUAL_INSTANTIATION
+#include "otbBinaryDilateImageFilter.txx"
+#endif
+
+#endif
diff --git a/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryDilateImageFilter.txx b/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryDilateImageFilter.txx
new file mode 100644
index 0000000000000000000000000000000000000000..7097eed73625d33691cd126e2f4987a83fe983fe
--- /dev/null
+++ b/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryDilateImageFilter.txx
@@ -0,0 +1,495 @@
+/*=========================================================================
+
+  Program:   Insight Segmentation & Registration Toolkit
+  Module:    $RCSfile: itkWatershedBoundaryResolver.h,v $
+  Language:  C++
+  Date:      $Date: 2009-04-23 03:53:37 $
+  Version:   $Revision: 1.12 $
+
+  Copyright (c) Insight Software Consortium. All rights reserved.
+  See ITKCopyright.txt or http://www.itk.org/HTML/Copyright.htm 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 __otbBinaryDilateImageFilter_txx
+#define __otbBinaryDilateImageFilter_txx
+
+#include "itkImageRegionIteratorWithIndex.h"
+#include "itkNeighborhoodInnerProduct.h"
+#include "itkImageRegionIterator.h"
+#include "itkNeighborhoodAlgorithm.h"
+#include "itkConstantBoundaryCondition.h"
+#include "itkOffset.h"
+#include "itkProgressReporter.h"
+#include "otbBinaryDilateImageFilter.h"
+
+namespace otb
+{
+template< class TInputImage, class TOutputImage, class TKernel >
+BinaryDilateImageFilter< TInputImage, TOutputImage, TKernel >
+::BinaryDilateImageFilter()
+{
+  this->m_BoundaryToForeground = false;
+}
+
+template< class TInputImage, class TOutputImage, class TKernel >
+void
+BinaryDilateImageFilter< TInputImage, TOutputImage, TKernel >
+::GenerateData()
+{
+  this->AllocateOutputs();
+
+  unsigned int i, j;
+
+  // Retrieve input and output pointers
+  typename OutputImageType::Pointer output = this->GetOutput();
+  typename InputImageType::ConstPointer input  = this->GetInput();
+
+  // Get values from superclass
+  InputPixelType foregroundValue = this->GetForegroundValue();
+  InputPixelType backgroundValue = this->GetBackgroundValue();
+  KernelType     kernel = this->GetKernel();
+  InputSizeType  radius;
+  radius.Fill(1);
+  typename TInputImage::RegionType inputRegion = input->GetBufferedRegion();
+  typename TOutputImage::RegionType outputRegion = output->GetBufferedRegion();
+
+  // compute the size of the temp image. It is needed to create the progress
+  // reporter.
+  // The tmp image needs to be large enough to support:
+  //   1. The size of the structuring element
+  //   2. The size of the connectivity element (typically one)
+  typename TInputImage::RegionType tmpRequestedRegion = outputRegion;
+  typename TInputImage::RegionType paddedInputRegion =
+    input->GetBufferedRegion();
+  paddedInputRegion.PadByRadius(radius);   // to support boundary values
+  InputSizeType padBy = radius;
+  for ( i = 0; i < KernelDimension; ++i )
+    {
+    padBy[i] = ( padBy[i] > kernel.GetRadius(i) ? padBy[i] : kernel.GetRadius(i) );
+    }
+  tmpRequestedRegion.PadByRadius(padBy);
+  tmpRequestedRegion.Crop(paddedInputRegion);
+
+  typename TInputImage::RegionType requiredInputRegion =
+    input->GetBufferedRegion();
+  requiredInputRegion.Crop(tmpRequestedRegion);
+
+  // Support progress methods/callbacks
+  // Setup a progress reporter.  We have 4 stages to the algorithm so
+  // pretend we have 4 times the number of pixels
+  itk::ProgressReporter progress( this, 0,
+                             outputRegion.GetNumberOfPixels() * 2
+                             + tmpRequestedRegion.GetNumberOfPixels()
+                             + requiredInputRegion.GetNumberOfPixels() );
+
+  // Allocate and reset output. We copy the input to the output,
+  // except for pixels with DilateValue.  These pixels are initially
+  // replaced with BackgroundValue and potentially replaced later with
+  // DilateValue as the Minkowski sums are performed.
+  itk::ImageRegionIterator< OutputImageType >     outIt(output, outputRegion);
+  itk::ImageRegionConstIterator< InputImageType > inIt(input, outputRegion);
+
+  for ( inIt.GoToBegin(), outIt.GoToBegin(); !outIt.IsAtEnd(); ++outIt, ++inIt )
+    {
+    InputPixelType value = inIt.Get();
+    // replace foreground pixels with the default background
+    if ( value == foregroundValue )
+      {
+      outIt.Set( static_cast< OutputPixelType >( backgroundValue ) );
+      }
+    // keep all of the original background values intact
+    else
+      {
+      outIt.Set( static_cast< OutputPixelType >( value ) );
+      }
+    progress.CompletedPixel();
+    }
+
+  // Create the temp image for surface encoding
+  // The temp image size is equal to the output requested region for thread
+  // padded by max( connectivity neighborhood radius, SE kernel radius ).
+  typedef itk::Image< unsigned char, TInputImage::ImageDimension > TempImageType;
+  typename TempImageType::Pointer tmpImage = TempImageType::New();
+
+  // Define regions of temp image
+  tmpImage->SetRegions(tmpRequestedRegion);
+
+  // Allocation.
+  // Pay attention to the fact that here, the output is still not
+  // allocated (so no extra memory needed for tmp image, if you
+  // consider that you reserve som memory space for output)
+  tmpImage->Allocate();
+
+  // First Stage
+  // Copy the input image to the tmp image.
+  // Tag the tmp Image.
+  //     zero means background
+  //     one means pixel on but not treated
+  //     two means border pixel
+  //     three means inner pixel
+  const unsigned char backgroundTag  = 0;
+  const unsigned char onTag          = 1;
+  const unsigned char borderTag      = 2;
+  const unsigned char innerTag       = 3;
+
+  if ( this->m_BoundaryToForeground )
+    {
+    tmpImage->FillBuffer(onTag);
+    }
+  else
+    {
+    tmpImage->FillBuffer(backgroundTag);
+    }
+
+  // Iterators on input and tmp image
+  // iterator on input
+  itk::ImageRegionConstIterator< TInputImage > iRegIt(input, requiredInputRegion);
+  // iterator on tmp image
+  itk::ImageRegionIterator< TempImageType > tmpRegIt(tmpImage, requiredInputRegion);
+
+  for ( iRegIt.GoToBegin(), tmpRegIt.GoToBegin();
+        !tmpRegIt.IsAtEnd();
+        ++iRegIt, ++tmpRegIt )
+    {
+    OutputPixelType pxl = iRegIt.Get();
+    if ( pxl == foregroundValue )
+      {
+      tmpRegIt.Set(onTag);
+      }
+    else
+      {
+      // by default if it is not foreground, consider
+      // it as background
+      tmpRegIt.Set(backgroundTag);
+      }
+    progress.CompletedPixel();
+    }
+
+  // Second stage
+  // Border tracking and encoding
+
+  // Need to record index, use an iterator with index
+  // Define iterators that will traverse the OUTPUT requested region
+  // for thread and not the padded one. The tmp image has been padded
+  // because in that way we will take care carefully at boundary
+  // pixels of output requested region.  Take care means that we will
+  // check if a boundary pixel is or not a border pixel.
+  itk::ImageRegionIteratorWithIndex< TempImageType >
+  tmpRegIndexIt(tmpImage, tmpRequestedRegion);
+
+  itk::ConstNeighborhoodIterator< TempImageType >
+  oNeighbIt(radius, tmpImage, tmpRequestedRegion);
+
+  // Define boundaries conditions
+  itk::ConstantBoundaryCondition< TempImageType > cbc;
+  cbc.SetConstant(backgroundTag);
+  oNeighbIt.OverrideBoundaryCondition(&cbc);
+
+  unsigned int neighborhoodSize = oNeighbIt.Size();
+  unsigned int centerPixelCode = neighborhoodSize / 2;
+
+  std::queue< IndexType > propagQueue;
+
+  // Neighborhood iterators used to track the surface.
+  //
+  // Note the region specified for the first neighborhood iterator is
+  // the requested region for the tmp image not the output image. This
+  // is necessary because the NeighborhoodIterator relies on the
+  // specified region to determine if you will ever query a boundary
+  // condition pixel.  Since we call SetLocation on the neighbor of a
+  // specified pixel, we have to set the region for the interator to
+  // include any pixel we may set our location to.
+  itk::NeighborhoodIterator< TempImageType >
+  nit(radius, tmpImage, tmpRequestedRegion);
+  nit.OverrideBoundaryCondition(&cbc);
+  nit.GoToBegin();
+
+  itk::ConstNeighborhoodIterator< TempImageType >
+  nnit(radius, tmpImage, tmpRequestedRegion);
+  nnit.OverrideBoundaryCondition(&cbc);
+  nnit.GoToBegin();
+
+  for ( tmpRegIndexIt.GoToBegin(), oNeighbIt.GoToBegin();
+        !tmpRegIndexIt.IsAtEnd();
+        ++tmpRegIndexIt, ++oNeighbIt )
+    {
+    // Test current pixel: it is active ( on ) or not?
+    if ( tmpRegIndexIt.Get() == onTag )
+      {
+      // The current pixel has not been treated previously.  That
+      // means that we do not know that it is an inner pixel of a
+      // border pixel.
+
+      // Test current pixel: it is a border pixel or an inner pixel?
+      bool bIsOnContour = false;
+
+      for ( i = 0; i < neighborhoodSize; ++i )
+        {
+        // If at least one neighbour pixel is off the center pixel
+        // belongs to contour
+        if ( oNeighbIt.GetPixel(i) == backgroundTag )
+          {
+          bIsOnContour = true;
+          break;
+          }
+        }
+
+      if ( bIsOnContour )
+        {
+        // center pixel is a border pixel and due to the parsing, it is also
+        // a pixel which belongs to a new border connected component
+        // Now we will parse this border thanks to a burn procedure
+
+        // mark pixel value as a border pixel
+        tmpRegIndexIt.Set(borderTag);
+
+        // add it to border container.
+        // its code is center pixel code because it is the first pixel
+        // of the connected component border
+
+        // paint the structuring element
+        typename NeighborIndexContainer::const_iterator itIdx;
+        NeighborIndexContainer & idxDifferenceSet =
+          this->GetDifferenceSet(centerPixelCode);
+        for ( itIdx = idxDifferenceSet.begin();
+              itIdx != idxDifferenceSet.end();
+              ++itIdx )
+          {
+          IndexType idx = tmpRegIndexIt.GetIndex() + *itIdx;
+          if ( outputRegion.IsInside(idx) )
+            {
+            output->SetPixel( idx, static_cast< OutputPixelType >( foregroundValue ) );
+            }
+          }
+
+        // add it to queue
+        propagQueue.push( tmpRegIndexIt.GetIndex() );
+
+        // now find all the border pixels
+        while ( !propagQueue.empty() )
+          {
+          // Extract pixel index from queue
+          IndexType currentIndex = propagQueue.front();
+          propagQueue.pop();
+
+          nit += currentIndex - nit.GetIndex();
+
+          for ( i = 0; i < neighborhoodSize; ++i )
+            {
+            // If pixel has not been already treated and it is a pixel
+            // on, test if it is an inner pixel or a border pixel
+
+            // Remark: all the pixels outside the image are set to
+            // backgroundTag thanks to boundary conditions. That means that if
+            // we enter in the next if-statement we are sure that the
+            // current neighbour pixel is in the image
+            if ( nit.GetPixel(i) == onTag )
+              {
+              // Check if it is an inner or border neighbour pixel
+              // Get index of current neighbour pixel
+              IndexType neighbIndex = nit.GetIndex(i);
+
+              // Force location of neighbour iterator
+              nnit += neighbIndex - nnit.GetIndex();
+
+              bool bIsOnBorder = false;
+
+              for ( j = 0; j < neighborhoodSize; ++j )
+                {
+                // If at least one neighbour pixel is off the center
+                // pixel belongs to border
+                if ( nnit.GetPixel(j) == backgroundTag )
+                  {
+                  bIsOnBorder = true;
+                  break;
+                  }
+                }
+
+              if ( bIsOnBorder )
+                {
+                // neighbour pixel is a border pixel
+                // mark it
+                bool status;
+                nit.SetPixel(i, borderTag, status);
+
+                // check whether we could set the pixel.  can only set
+                // the pixel if it is within the tmpimage
+                if ( status )
+                  {
+                  // add it to queue
+                  propagQueue.push(neighbIndex);
+
+                  // paint the structuring element
+                  typename NeighborIndexContainer::const_iterator itIndex;
+                  NeighborIndexContainer & indexDifferenceSet =
+                    this->GetDifferenceSet(i);
+                  for ( itIndex = indexDifferenceSet.begin();
+                        itIndex != indexDifferenceSet.end();
+                        ++itIndex )
+                    {
+                    IndexType idx = neighbIndex + *itIndex;
+                    if ( outputRegion.IsInside(idx) )
+                      {
+                      output->SetPixel( idx, static_cast< OutputPixelType >( foregroundValue ) );
+                      }
+                    }
+                  }
+                }
+              else
+                {
+                // neighbour pixel is an inner pixel
+                bool status;
+                nit.SetPixel(i, innerTag, status);
+                }
+
+              progress.CompletedPixel();
+              } // if( nit.GetPixel( i ) == onTag )
+            }   // for (i = 0; i < neighborhoodSize; ++i)
+          }     // while ( !propagQueue.empty() )
+        }       // if( bIsOnCountour )
+      else
+        {
+        tmpRegIndexIt.Set(innerTag);
+        }
+      } // if( tmpRegIndexIt.Get() == onTag )
+    else
+      {
+      progress.CompletedPixel();
+      }
+    // Here, the pixel is a background pixel ( value at 0 ) or an
+    // already treated pixel:
+    //     2 for border pixel, 3 for inner pixel
+    }
+
+  // Deallocate tmpImage
+  tmpImage->Initialize();
+
+  // Third Stage
+  // traverse structure of border and SE CCs, and paint output image
+
+  // Let's consider the the set of the ON elements of the input image as X.
+  //
+  // Let's consider the structuring element as B = {B0, B1, ..., Bn},
+  // where Bi denotes a connected component of B.
+  //
+  // Let's consider bi, i in [0,n], an arbitrary point of Bi.
+  //
+
+  // We use hence the next property in order to compute minkoswki
+  // addition ( which will be written (+) ):
+  //
+  // X (+) B = ( Xb0 UNION Xb1 UNION ... Xbn ) UNION ( BORDER(X) (+) B ),
+  //
+  // where Xbi is the set X translated with respect to vector bi :
+  //
+  // Xbi = { x + bi, x belongs to X } where BORDER(X) is the extracted
+  // border of X ( 8 connectivity in 2D, 26 in 3D )
+
+  // Define boundaries conditions
+  itk::ConstantBoundaryCondition< TOutputImage > obc;
+  obc.SetConstant( static_cast< OutputPixelType >( backgroundValue ) );
+
+  itk::NeighborhoodIterator< OutputImageType >
+  onit(kernel.GetRadius(), output, outputRegion);
+  onit.OverrideBoundaryCondition(&obc);
+  onit.GoToBegin();
+
+  // Paint input image translated with respect to the SE CCs vectors
+  // --> "( Xb0 UNION Xb1 UNION ... Xbn )"
+  typename Superclass::ComponentVectorConstIterator vecIt;
+  typename Superclass::ComponentVectorConstIterator vecBeginIt =
+    this->KernelCCVectorBegin();
+  typename Superclass::ComponentVectorConstIterator vecEndIt =
+    this->KernelCCVectorEnd();
+
+  // iterator on output image
+  itk::ImageRegionIteratorWithIndex< OutputImageType >
+  ouRegIndexIt(output, outputRegion);
+  ouRegIndexIt.GoToBegin();
+
+  // InputRegionForThread is the output region for thread padded by
+  // kerne lradius We must traverse this padded region because some
+  // border pixel in the added band ( the padded band is the region
+  // added after padding ) may be responsible to the painting of some
+  // pixel in the non padded region.  This happens typically when a
+  // non centered SE is used, a kind of shift is done on the "on"
+  // pixels of image. Consequently some pixels in the added band can
+  // appear in the current region for thread due to shift effect.
+  typename InputImageType::RegionType inputRegionForThread = outputRegion;
+
+  // Pad the input region by the kernel
+  inputRegionForThread.PadByRadius( kernel.GetRadius() );
+  inputRegionForThread.Crop( input->GetBufferedRegion() );
+
+  if ( this->m_BoundaryToForeground )
+    {
+    while ( !ouRegIndexIt.IsAtEnd() )
+      {
+      // Retrieve index of current output pixel
+      IndexType currentIndex  = ouRegIndexIt.GetIndex();
+      for ( vecIt = vecBeginIt; vecIt != vecEndIt; ++vecIt )
+        {
+        // Translate
+        IndexType translatedIndex = currentIndex - *vecIt;
+
+        // translated index now is an index in input image in the
+        // output requested region padded. Theoretically, this translated
+        // index must be inside the padded region.
+        // If the pixel in the input image at the translated index
+        // has a value equal to the dilate one, this means
+        // that the output pixel at currentIndex will be on in the output.
+        if ( !inputRegionForThread.IsInside(translatedIndex)
+             || input->GetPixel(translatedIndex) == foregroundValue )
+          {
+          ouRegIndexIt.Set( static_cast< OutputPixelType >( foregroundValue ) );
+          break; // Do not need to examine other offsets because at least one
+          // input pixel has been translated on current output pixel.
+          }
+        }
+
+      ++ouRegIndexIt;
+      progress.CompletedPixel();
+      }
+    }
+  else
+    {
+    while ( !ouRegIndexIt.IsAtEnd() )
+      {
+      IndexType currentIndex  = ouRegIndexIt.GetIndex();
+      for ( vecIt = vecBeginIt; vecIt != vecEndIt; ++vecIt )
+        {
+        IndexType translatedIndex = currentIndex - *vecIt;
+
+        if ( inputRegionForThread.IsInside(translatedIndex)
+             && input->GetPixel(translatedIndex) == foregroundValue )
+          {
+          ouRegIndexIt.Set( static_cast< OutputPixelType >( foregroundValue ) );
+          break;
+          }
+        }
+
+      ++ouRegIndexIt;
+      progress.CompletedPixel();
+      }
+    }
+}
+
+/**
+ * Standard "PrintSelf" method
+ */
+template< class TInputImage, class TOutput, class TKernel >
+void
+BinaryDilateImageFilter< TInputImage, TOutput, TKernel >
+::PrintSelf(std::ostream & os, itk::Indent indent) const
+{
+  Superclass::PrintSelf(os, indent);
+  os << indent << "Dilate Value: "
+     << static_cast< typename itk::NumericTraits< InputPixelType >::PrintType >( this->GetForegroundValue() ) << std::endl;
+}
+} // end namespace itk
+
+#endif
diff --git a/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryErodeImageFilter.h b/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryErodeImageFilter.h
new file mode 100644
index 0000000000000000000000000000000000000000..322d10ae6783ca6f5b35426edc10c1e06fd22615
--- /dev/null
+++ b/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryErodeImageFilter.h
@@ -0,0 +1,145 @@
+/*=========================================================================
+
+  Program:   Insight Segmentation & Registration Toolkit
+  Module:    $RCSfile: itkWatershedBoundaryResolver.h,v $
+  Language:  C++
+  Date:      $Date: 2009-04-23 03:53:37 $
+  Version:   $Revision: 1.12 $
+
+  Copyright (c) Insight Software Consortium. All rights reserved.
+  See ITKCopyright.txt or http://www.itk.org/HTML/Copyright.htm 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 __otbBinaryErodeImageFilter_h
+#define __otbBinaryErodeImageFilter_h
+
+#include <vector>
+#include <queue>
+#include "itkBinaryMorphologyImageFilter.h"
+#include "itkConstNeighborhoodIterator.h"
+
+namespace otb
+{
+/**
+ * \class BinaryErodeImageFilter
+ * \brief Fast binary erosion
+ *
+ * BinaryErodeImageFilter is a binary erosion
+ * morphologic operation. This implementation is based on the papers:
+ *
+ * L.Vincent "Morphological transformations of binary images with
+ * arbitrary structuring elements", and
+ *
+ * N.Nikopoulos et al. "An efficient algorithm for 3d binary
+ * morphological transformations with 3d structuring elements
+ * for arbitrary size and shape". IEEE Transactions on Image
+ * Processing. Vol. 9. No. 3. 2000. pp. 283-286.
+ *
+ * Gray scale images can be processed as binary images by selecting a
+ * "ErodeValue".  Pixel values matching the erode value are
+ * considered the "foreground" and all other pixels are
+ * "background". This is useful in processing segmented images where
+ * all pixels in segment #1 have value 1 and pixels in segment #2 have
+ * value 2, etc. A particular "segment number" can be processed.
+ * ErodeValue defaults to the maximum possible value of the
+ * PixelType. The eroded pixels will receive the BackgroundValue
+ * (defaults to 0).
+ *
+ * The structuring element is assumed to be composed of binary values
+ * (zero or one). Only elements of the structuring element having
+ * values > 0 are candidates for affecting the center pixel.  A
+ * reasonable choice of structuring element is
+ * itk::BinaryBallStructuringElement.
+ *
+ * \sa ImageToImageFilter BinaryDilateImageFilter BinaryMorphologyImageFilter
+ * \ingroup ITKBinaryMathematicalMorphology
+ *
+ * \wiki
+ * \wikiexample{Morphology/BinaryErodeImageFilter,Erode a binary image}
+ * \endwiki
+ */
+template< class TInputImage, class TOutputImage, class TKernel >
+class ITK_EXPORT BinaryErodeImageFilter:
+    public itk::BinaryMorphologyImageFilter< TInputImage, TOutputImage, TKernel >
+{
+public:
+  /** Extract dimension from input and output image. */
+  itkStaticConstMacro(InputImageDimension, unsigned int,
+                      TInputImage::ImageDimension);
+  itkStaticConstMacro(OutputImageDimension, unsigned int,
+                      TOutputImage::ImageDimension);
+
+  /** Extract the dimension of the kernel */
+  itkStaticConstMacro(KernelDimension, unsigned int,
+                      TKernel::NeighborhoodDimension);
+
+  /** Convenient typedefs for simplifying declarations. */
+  typedef TInputImage  InputImageType;
+  typedef TOutputImage OutputImageType;
+  typedef TKernel      KernelType;
+
+  /** Standard class typedefs. */
+  typedef BinaryErodeImageFilter Self;
+  typedef itk::BinaryMorphologyImageFilter< InputImageType, OutputImageType,
+                                       KernelType > Superclass;
+
+  typedef itk::SmartPointer< Self >       Pointer;
+  typedef itk::SmartPointer< const Self > ConstPointer;
+
+  /** Method for creation through the object factory. */
+  itkNewMacro(Self);
+
+  /** Run-time type information (and related methods). */
+  itkTypeMacro(BinaryErodeImageFilter, BinaryMorphologyImageFilter);
+
+  /** Kernel (structuring element) iterator. */
+  typedef typename KernelType::ConstIterator KernelIteratorType;
+
+  /** Image typedef support. */
+  typedef typename InputImageType::PixelType                 InputPixelType;
+  typedef typename OutputImageType::PixelType                OutputPixelType;
+  typedef typename itk::NumericTraits< InputPixelType >::RealType InputRealType;
+  typedef typename InputImageType::OffsetType                OffsetType;
+  typedef typename InputImageType::IndexType                 IndexType;
+
+  typedef typename InputImageType::RegionType  InputImageRegionType;
+  typedef typename OutputImageType::RegionType OutputImageRegionType;
+  typedef typename InputImageType::SizeType    InputSizeType;
+
+  /** Set the value in the image to consider as "foreground". Defaults to
+   * maximum value of PixelType. This is an alias to the
+   * ForegroundValue in the superclass. */
+  void SetErodeValue(const InputPixelType & value)
+  { this->SetForegroundValue(value); }
+
+  /** Get the value in the image considered as "foreground". Defaults to
+   * maximum value of PixelType. This is an alias to the
+   * ForegroundValue in the superclass. */
+  InputPixelType GetErodeValue() const
+  { return this->GetForegroundValue(); }
+
+protected:
+  BinaryErodeImageFilter();
+  virtual ~BinaryErodeImageFilter(){}
+  void PrintSelf(std::ostream & os, itk::Indent indent) const;
+
+  void GenerateData();
+
+  // type inherited from the superclass
+  typedef typename Superclass::NeighborIndexContainer NeighborIndexContainer;
+
+private:
+  BinaryErodeImageFilter(const Self &); //purposely not implemented
+  void operator=(const Self &);         //purposely not implemented
+};
+} // end namespace itk
+
+#ifndef ITK_MANUAL_INSTANTIATION
+#include "otbBinaryErodeImageFilter.txx"
+#endif
+
+#endif
diff --git a/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryErodeImageFilter.txx b/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryErodeImageFilter.txx
new file mode 100644
index 0000000000000000000000000000000000000000..5cf10eccd1889eb7458781914193ad5225fa4d25
--- /dev/null
+++ b/Code/UtilitiesAdapters/ITKPendingPatches/otbBinaryErodeImageFilter.txx
@@ -0,0 +1,503 @@
+/*=========================================================================
+
+  Program:   Insight Segmentation & Registration Toolkit
+  Module:    $RCSfile: itkWatershedBoundaryResolver.h,v $
+  Language:  C++
+  Date:      $Date: 2009-04-23 03:53:37 $
+  Version:   $Revision: 1.12 $
+
+  Copyright (c) Insight Software Consortium. All rights reserved.
+  See ITKCopyright.txt or http://www.itk.org/HTML/Copyright.htm 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 __otbBinaryErodeImageFilter_txx
+#define __otbBinaryErodeImageFilter_txx
+
+#include "itkImageRegionIteratorWithIndex.h"
+#include "itkNeighborhoodInnerProduct.h"
+#include "itkImageRegionConstIterator.h"
+#include "itkNeighborhoodAlgorithm.h"
+#include "itkConstantBoundaryCondition.h"
+#include "itkOffset.h"
+#include "itkProgressReporter.h"
+#include "otbBinaryErodeImageFilter.h"
+
+namespace otb
+{
+template< class TInputImage, class TOutputImage, class TKernel >
+BinaryErodeImageFilter< TInputImage, TOutputImage, TKernel >
+::BinaryErodeImageFilter()
+{
+  this->m_BoundaryToForeground = true;
+}
+
+template< class TInputImage, class TOutputImage, class TKernel >
+void
+BinaryErodeImageFilter< TInputImage, TOutputImage, TKernel >
+::GenerateData()
+{
+  this->AllocateOutputs();
+
+  unsigned int i, j;
+
+  // Retrieve input and output pointers
+  typename OutputImageType::Pointer output = this->GetOutput();
+  typename InputImageType::ConstPointer input  = this->GetInput();
+
+  // Get values from superclass
+  InputPixelType foregroundValue = this->GetForegroundValue();
+  InputPixelType backgroundValue = this->GetBackgroundValue();
+  KernelType     kernel = this->GetKernel();
+  InputSizeType  radius;
+  radius.Fill(1);
+  typename TInputImage::RegionType inputRegion = input->GetBufferedRegion();
+  typename TOutputImage::RegionType outputRegion = output->GetBufferedRegion();
+
+  // compute the size of the temp image. It is needed to create the progress
+  // reporter.
+  // The tmp image needs to be large enough to support:
+  //   1. The size of the structuring element
+  //   2. The size of the connectivity element (typically one)
+  typename TInputImage::RegionType tmpRequestedRegion = outputRegion;
+  typename TInputImage::RegionType paddedInputRegion =
+    input->GetBufferedRegion();
+  paddedInputRegion.PadByRadius(radius);   // to support boundary values
+  InputSizeType padBy = radius;
+  for ( i = 0; i < KernelDimension; ++i )
+    {
+    padBy[i] = ( padBy[i] > kernel.GetRadius(i) ? padBy[i] : kernel.GetRadius(i) );
+    }
+  tmpRequestedRegion.PadByRadius(padBy);
+  tmpRequestedRegion.Crop(paddedInputRegion);
+
+  typename TInputImage::RegionType requiredInputRegion =
+    input->GetBufferedRegion();
+  requiredInputRegion.Crop(tmpRequestedRegion);
+
+  // Support progress methods/callbacks
+  // Setup a progress reporter.  We have 4 stages to the algorithm so
+  // pretend we have 4 times the number of pixels
+  itk::ProgressReporter progress( this, 0,
+                             outputRegion.GetNumberOfPixels() * 3
+                             + tmpRequestedRegion.GetNumberOfPixels()
+                             + requiredInputRegion.GetNumberOfPixels() );
+
+  // Allocate and reset output. We copy the input to the output,
+  // except for pixels with DilateValue.  These pixels are initially
+  // replaced with BackgroundValue and potentially replaced later with
+  // DilateValue as the Minkowski sums are performed.
+  itk::ImageRegionIterator< OutputImageType > outIt(output, outputRegion);
+  //ImageRegionConstIterator<InputImageType> inIt( input, outputRegion );
+
+  for ( outIt.GoToBegin(); !outIt.IsAtEnd(); ++outIt )
+    {
+    outIt.Set(foregroundValue);
+    progress.CompletedPixel();
+    }
+
+  // Create the temp image for surface encoding
+  // The temp image size is equal to the output requested region for thread
+  // padded by max( connectivity neighborhood radius, SE kernel radius ).
+  typedef itk::Image< unsigned char, TInputImage::ImageDimension > TempImageType;
+  typename TempImageType::Pointer tmpImage = TempImageType::New();
+
+  // Define regions of temp image
+  tmpImage->SetRegions(tmpRequestedRegion);
+
+  // Allocation.
+  // Pay attention to the fact that here, the output is still not
+  // allocated (so no extra memory needed for tmp image, if you
+  // consider that you reserve som memory space for output)
+  tmpImage->Allocate();
+
+  // First Stage
+  // Copy the input image to the tmp image.
+  // Tag the tmp Image.
+  //     zero means background
+  //     one means pixel on but not treated
+  //     two means border pixel
+  //     three means inner pixel
+  const unsigned char backgroundTag  = 0;
+  const unsigned char onTag          = 1;
+  const unsigned char borderTag      = 2;
+  const unsigned char innerTag       = 3;
+
+  if ( !this->m_BoundaryToForeground )
+    {
+    tmpImage->FillBuffer(onTag);
+    }
+  else
+    {
+    tmpImage->FillBuffer(backgroundTag);
+    }
+
+  // Iterators on input and tmp image
+  // iterator on input
+  itk::ImageRegionConstIterator< TInputImage > iRegIt(input, requiredInputRegion);
+  // iterator on tmp image
+  itk::ImageRegionIterator< TempImageType > tmpRegIt(tmpImage, requiredInputRegion);
+
+  for ( iRegIt.GoToBegin(), tmpRegIt.GoToBegin();
+        !tmpRegIt.IsAtEnd();
+        ++iRegIt, ++tmpRegIt )
+    {
+    OutputPixelType pxl = iRegIt.Get();
+    if ( pxl != foregroundValue )
+      {
+      tmpRegIt.Set(onTag);
+      }
+    else
+      {
+      // by default if it is not foreground, consider
+      // it as background
+      tmpRegIt.Set(backgroundTag);
+      }
+    progress.CompletedPixel();
+    }
+
+  // Second stage
+  // Border tracking and encoding
+
+  // Need to record index, use an iterator with index
+  // Define iterators that will traverse the OUTPUT requested region
+  // for thread and not the padded one. The tmp image has been padded
+  // because in that way we will take care carefully at boundary
+  // pixels of output requested region.  Take care means that we will
+  // check if a boundary pixel is or not a border pixel.
+  itk::ImageRegionIteratorWithIndex< TempImageType >
+  tmpRegIndexIt(tmpImage, tmpRequestedRegion);
+
+  itk::ConstNeighborhoodIterator< TempImageType >
+  oNeighbIt(radius, tmpImage, tmpRequestedRegion);
+
+  // Define boundaries conditions
+  itk::ConstantBoundaryCondition< TempImageType > cbc;
+  cbc.SetConstant(backgroundTag);
+  oNeighbIt.OverrideBoundaryCondition(&cbc);
+
+  unsigned int neighborhoodSize = oNeighbIt.Size();
+  unsigned int centerPixelCode = neighborhoodSize / 2;
+
+  std::queue< IndexType > propagQueue;
+
+  // Neighborhood iterators used to track the surface.
+  //
+  // Note the region specified for the first neighborhood iterator is
+  // the requested region for the tmp image not the output image. This
+  // is necessary because the NeighborhoodIterator relies on the
+  // specified region to determine if you will ever query a boundary
+  // condition pixel.  Since we call SetLocation on the neighbor of a
+  // specified pixel, we have to set the region for the interator to
+  // include any pixel we may set our location to.
+  itk::NeighborhoodIterator< TempImageType >
+  nit(radius, tmpImage, tmpRequestedRegion);
+  nit.OverrideBoundaryCondition(&cbc);
+  nit.GoToBegin();
+
+  itk::ConstNeighborhoodIterator< TempImageType >
+  nnit(radius, tmpImage, tmpRequestedRegion);
+  nnit.OverrideBoundaryCondition(&cbc);
+  nnit.GoToBegin();
+
+  for ( tmpRegIndexIt.GoToBegin(), oNeighbIt.GoToBegin();
+        !tmpRegIndexIt.IsAtEnd();
+        ++tmpRegIndexIt, ++oNeighbIt )
+    {
+    unsigned char tmpValue = tmpRegIndexIt.Get();
+
+    // Test current pixel: it is active ( on ) or not?
+    if ( tmpValue == onTag )
+      {
+      // The current pixel has not been treated previously.  That
+      // means that we do not know that it is an inner pixel of a
+      // border pixel.
+
+      // Test current pixel: it is a border pixel or an inner pixel?
+      bool bIsOnContour = false;
+
+      for ( i = 0; i < neighborhoodSize; ++i )
+        {
+        // If at least one neighbour pixel is off the center pixel
+        // belongs to contour
+        if ( oNeighbIt.GetPixel(i) == backgroundTag )
+          {
+          bIsOnContour = true;
+          break;
+          }
+        }
+
+      if ( bIsOnContour )
+        {
+        // center pixel is a border pixel and due to the parsing, it is also
+        // a pixel which belongs to a new border connected component
+        // Now we will parse this border thanks to a burn procedure
+
+        // mark pixel value as a border pixel
+        tmpRegIndexIt.Set(borderTag);
+
+        // add it to border container.
+        // its code is center pixel code because it is the first pixel
+        // of the connected component border
+
+        // paint the structuring element
+        typename NeighborIndexContainer::const_iterator itIdx;
+        NeighborIndexContainer & idxDifferenceSet =
+          this->GetDifferenceSet(centerPixelCode);
+        for ( itIdx = idxDifferenceSet.begin();
+              itIdx != idxDifferenceSet.end();
+              ++itIdx )
+          {
+          IndexType idx = tmpRegIndexIt.GetIndex() + *itIdx;
+          if ( outputRegion.IsInside(idx) )
+            {
+            output->SetPixel(idx, backgroundValue);
+            }
+          }
+
+        // add it to queue
+        propagQueue.push( tmpRegIndexIt.GetIndex() );
+
+        // now find all the border pixels
+        while ( !propagQueue.empty() )
+          {
+          // Extract pixel index from queue
+          IndexType currentIndex = propagQueue.front();
+          propagQueue.pop();
+
+          nit += currentIndex - nit.GetIndex();
+
+          for ( i = 0; i < neighborhoodSize; ++i )
+            {
+            // If pixel has not been already treated and it is a pixel
+            // on, test if it is an inner pixel or a border pixel
+
+            // Remark: all the pixels outside the image are set to
+            // backgroundTag thanks to boundary conditions. That means that if
+            // we enter in the next if-statement we are sure that the
+            // current neighbour pixel is in the image
+            if ( nit.GetPixel(i) == onTag )
+              {
+              // Check if it is an inner or border neighbour pixel
+              // Get index of current neighbour pixel
+              IndexType neighbIndex = nit.GetIndex(i);
+
+              // Force location of neighbour iterator
+              nnit += neighbIndex - nnit.GetIndex();
+
+              bool bIsOnBorder = false;
+
+              for ( j = 0; j < neighborhoodSize; ++j )
+                {
+                // If at least one neighbour pixel is off the center
+                // pixel belongs to border
+                if ( nnit.GetPixel(j) == backgroundTag )
+                  {
+                  bIsOnBorder = true;
+                  break;
+                  }
+                }
+
+              if ( bIsOnBorder )
+                {
+                // neighbour pixel is a border pixel
+                // mark it
+                bool status;
+                nit.SetPixel(i, borderTag, status);
+
+                // check whether we could set the pixel.  can only set
+                // the pixel if it is within the tmpimage
+                if ( status )
+                  {
+                  // add it to queue
+                  propagQueue.push(neighbIndex);
+
+                  // paint the structuring element
+                  typename NeighborIndexContainer::const_iterator itIndex;
+                  NeighborIndexContainer & indexDifferenceSet =
+                    this->GetDifferenceSet(i);
+                  for ( itIndex = indexDifferenceSet.begin();
+                        itIndex != indexDifferenceSet.end();
+                        ++itIndex )
+                    {
+                    IndexType idx = neighbIndex + *itIndex;
+                    if ( outputRegion.IsInside(idx) )
+                      {
+                      output->SetPixel(idx, backgroundValue);
+                      }
+                    }
+                  }
+                }
+              else
+                {
+                // neighbour pixel is an inner pixel
+                bool status;
+                nit.SetPixel(i, innerTag, status);
+                }
+
+              progress.CompletedPixel();
+              } // if( nit.GetPixel( i ) == onTag )
+            }   // for (i = 0; i < neighborhoodSize; ++i)
+          }     // while ( !propagQueue.empty() )
+        }       // if( bIsOnCountour )
+      else
+        {
+        tmpRegIndexIt.Set(innerTag);
+        }
+
+      progress.CompletedPixel();
+      } // if( tmpRegIndexIt.Get() == onTag )
+    else if ( tmpValue == backgroundTag )
+      {
+      progress.CompletedPixel();
+      }
+    // Here, the pixel is a background pixel ( value at 0 ) or an
+    // already treated pixel:
+    //     2 for border pixel, 3 for inner pixel
+    }
+
+  // Deallocate tmpImage
+  tmpImage->Initialize();
+
+  // Third Stage
+  // traverse structure of border and SE CCs, and paint output image
+
+  // Let's consider the the set of the ON elements of the input image as X.
+  //
+  // Let's consider the structuring element as B = {B0, B1, ..., Bn},
+  // where Bi denotes a connected component of B.
+  //
+  // Let's consider bi, i in [0,n], an arbitrary point of Bi.
+  //
+
+  // We use hence the next property in order to compute minkoswki
+  // addition ( which will be written (+) ):
+  //
+  // X (+) B = ( Xb0 UNION Xb1 UNION ... Xbn ) UNION ( BORDER(X) (+) B ),
+  //
+  // where Xbi is the set X translated with respect to vector bi :
+  //
+  // Xbi = { x + bi, x belongs to X } where BORDER(X) is the extracted
+  // border of X ( 8 connectivity in 2D, 26 in 3D )
+
+  // Define boundaries conditions
+  itk::ConstantBoundaryCondition< TOutputImage > obc;
+  obc.SetConstant(backgroundValue);
+
+  itk::NeighborhoodIterator< OutputImageType >
+  onit(kernel.GetRadius(), output, outputRegion);
+  onit.OverrideBoundaryCondition(&obc);
+  onit.GoToBegin();
+
+  // Paint input image translated with respect to the SE CCs vectors
+  // --> "( Xb0 UNION Xb1 UNION ... Xbn )"
+  typename Superclass::ComponentVectorConstIterator vecIt;
+  typename Superclass::ComponentVectorConstIterator vecBeginIt =
+    this->KernelCCVectorBegin();
+  typename Superclass::ComponentVectorConstIterator vecEndIt =
+    this->KernelCCVectorEnd();
+
+  // iterator on output image
+  itk::ImageRegionIteratorWithIndex< OutputImageType >
+  ouRegIndexIt(output, outputRegion);
+  ouRegIndexIt.GoToBegin();
+
+  // InputRegionForThread is the output region for thread padded by
+  // kerne lradius We must traverse this padded region because some
+  // border pixel in the added band ( the padded band is the region
+  // added after padding ) may be responsible to the painting of some
+  // pixel in the non padded region.  This happens typically when a
+  // non centered SE is used, a kind of shift is done on the "on"
+  // pixels of image. Consequently some pixels in the added band can
+  // appear in the current region for thread due to shift effect.
+  typename InputImageType::RegionType inputRegionForThread = outputRegion;
+
+  // Pad the input region by the kernel
+  inputRegionForThread.PadByRadius( kernel.GetRadius() );
+  inputRegionForThread.Crop( input->GetBufferedRegion() );
+
+  if ( !this->m_BoundaryToForeground )
+    {
+    while ( !ouRegIndexIt.IsAtEnd() )
+      {
+      // Retrieve index of current output pixel
+      IndexType currentIndex  = ouRegIndexIt.GetIndex();
+      for ( vecIt = vecBeginIt; vecIt != vecEndIt; ++vecIt )
+        {
+        // Translate
+        IndexType translatedIndex = currentIndex - *vecIt;
+
+        // translated index now is an index in input image in the
+        // output requested region padded. Theoretically, this translated
+        // index must be inside the padded region.
+        // If the pixel in the input image at the translated index
+        // has a value equal to the dilate one, this means
+        // that the output pixel at currentIndex will be on in the output.
+        if ( !inputRegionForThread.IsInside(translatedIndex)
+             || input->GetPixel(translatedIndex) != foregroundValue )
+          {
+          ouRegIndexIt.Set(backgroundValue);
+          break; // Do not need to examine other offsets because at least one
+          // input pixel has been translated on current output pixel.
+          }
+        }
+
+      ++ouRegIndexIt;
+      progress.CompletedPixel();
+      }
+    }
+  else
+    {
+    while ( !ouRegIndexIt.IsAtEnd() )
+      {
+      IndexType currentIndex  = ouRegIndexIt.GetIndex();
+      for ( vecIt = vecBeginIt; vecIt != vecEndIt; ++vecIt )
+        {
+        IndexType translatedIndex = currentIndex - *vecIt;
+
+        if ( inputRegionForThread.IsInside(translatedIndex)
+             && input->GetPixel(translatedIndex) != foregroundValue )
+          {
+          ouRegIndexIt.Set(backgroundValue);
+          break;
+          }
+        }
+
+      ++ouRegIndexIt;
+      progress.CompletedPixel();
+      }
+    }
+
+  // now, we must to restore the background values
+  itk::ImageRegionConstIterator< InputImageType > inIt(input, outputRegion);
+
+  for ( inIt.GoToBegin(), outIt.GoToBegin(); !outIt.IsAtEnd(); ++outIt, ++inIt )
+    {
+    InputPixelType  inValue = inIt.Get();
+    OutputPixelType outValue = outIt.Get();
+    if ( outValue == backgroundValue && inValue != foregroundValue )
+      {
+      outIt.Set( static_cast< OutputPixelType >( inValue ) );
+      }
+    progress.CompletedPixel();
+    }
+}
+
+/**
+ * Standard "PrintSelf" method
+ */
+template< class TInputImage, class TOutput, class TKernel >
+void
+BinaryErodeImageFilter< TInputImage, TOutput, TKernel >
+::PrintSelf(std::ostream & os, itk::Indent indent) const
+{
+  Superclass::PrintSelf(os, indent);
+  os << indent << "Dilate Value: "
+     << static_cast< typename itk::NumericTraits< InputPixelType >::PrintType >( this->GetForegroundValue() ) << std::endl;
+}
+} // end namespace itk
+
+#endif