Main Page   Groups   Namespace List   Class Hierarchy   Alphabetical List   Compound List   File List   Namespace Members   Compound Members   File Members   Concepts
Typedefs | Functions | Variables

HardConnectedComponentImageFilter Namespace Reference

Typedefs

typedef SmartPointer< const SelfConstPointer
typedef TInputImage::IndexType IndexType
typedef TInputImage InputImageType
typedef std::list< IndexTypeListType
typedef TOutputImage OutputImageType
typedef SmartPointer< SelfPointer
typedef TOutputImage::RegionType RegionType
typedef
HardConnectedComponentImageFilter 
Self
typedef TInputImage::SizeType SizeType
typedef ImageToImageFilter
< TInputImage, TOutputImage > 
Superclass

Functions

virtual const char * GetNameOfClass () const
 HardConnectedComponentImageFilter ()
 HardConnectedComponentImageFilter (const Self &)
static Pointer New ()
void SetObjectSeed (const IndexType &seed)
virtual ~HardConnectedComponentImageFilter ()

void GenerateData ()
void PrintSelf (std::ostream &os, Indent indent) const

Variables

ListType m_Seeds



typedef TOutputImage::PixelType OutputPixelType
typedef
TOutputImage::InternalPixelType 
OutputInternalPixelType
typedef TInputImage::PixelType InputPixelType
typedef
TInputImage::InternalPixelType 
InputInternalPixelType
static const unsigned int InputImageDimension = TInputImage::ImageDimension
static const unsigned int ImageDimension = TOutputImage::ImageDimension

Detailed Description

The purpose of this program is to produce the connected components for any input binary image of dimensionality n.

The program does a forward pass line by line through the entire image. Each cell in the foreground is assigned the same label value as cells in its neighborhood. If there is no label among the cells in its neighborhood, a new label value is assigned to the cell. This means that this cell belongs to a different connected component. We set up an equivalence table for each label to indicate the equivalence of the labels stored in the table. After the forward pass goes through the entire image, we merge the different connected components corresponding to the equivalence labels in the table. We implement this strategy in function GenerateData().

There are two options in the program. 1. Take an nD binary image as input, and produce an nD gray image, where intensity indicates label assigned to a connected component. 2. Take an nD binary image and a set of seed points as input, and output an nD binary image containing the cells connected to the seeds. For option 2, users need to assign the member variable std::list<IndexType> m_Seeds before calling function GenerateData().

See also:
ImageToImageFilter

Typedef Documentation

Definition at line 89 of file itkHardConnectedComponentImageFilter.h.

typedef TInputImage::IndexType HardConnectedComponentImageFilter::IndexType

Image typedef support

Definition at line 78 of file itkHardConnectedComponentImageFilter.h.

typedef TInputImage::InternalPixelType HardConnectedComponentImageFilter::InputInternalPixelType

Extract some information from the image types. Dimensionality of the two images is assumed to be the same.

Definition at line 68 of file itkHardConnectedComponentImageFilter.h.

typedef TInputImage::PixelType HardConnectedComponentImageFilter::InputPixelType

Extract some information from the image types. Dimensionality of the two images is assumed to be the same.

Definition at line 67 of file itkHardConnectedComponentImageFilter.h.

Definition at line 83 of file itkHardConnectedComponentImageFilter.h.

Definition at line 79 of file itkHardConnectedComponentImageFilter.h.

typedef TOutputImage::InternalPixelType HardConnectedComponentImageFilter::OutputInternalPixelType

Extract some information from the image types. Dimensionality of the two images is assumed to be the same.

Definition at line 66 of file itkHardConnectedComponentImageFilter.h.

typedef TOutputImage::PixelType HardConnectedComponentImageFilter::OutputPixelType

Extract some information from the image types. Dimensionality of the two images is assumed to be the same.

Definition at line 65 of file itkHardConnectedComponentImageFilter.h.

Smart pointer typedef support

Definition at line 88 of file itkHardConnectedComponentImageFilter.h.

typedef TOutputImage::RegionType HardConnectedComponentImageFilter::RegionType
typedef HardConnectedComponentImageFilter HardConnectedComponentImageFilter::Self

Standard "Self" & Superclass typedef.

Definition at line 58 of file itkHardConnectedComponentImageFilter.h.

typedef TInputImage::SizeType HardConnectedComponentImageFilter::SizeType
typedef ImageToImageFilter< TInputImage, TOutputImage > HardConnectedComponentImageFilter::Superclass

Definition at line 59 of file itkHardConnectedComponentImageFilter.h.


Function Documentation

void HardConnectedComponentImageFilter::GenerateData (  )  [protected]
virtual const char* HardConnectedComponentImageFilter::GetNameOfClass (  )  const [virtual]

Run-time type information (and related methods)

HardConnectedComponentImageFilter::HardConnectedComponentImageFilter (  )  [protected]

Definition at line 124 of file itkHardConnectedComponentImageFilter.h.

HardConnectedComponentImageFilter::HardConnectedComponentImageFilter ( const Self &   )  [protected]

Definition at line 126 of file itkHardConnectedComponentImageFilter.h.

static Pointer HardConnectedComponentImageFilter::New (  )  [static]

Method for creation through the object factory.

Examples:
Common/itkImageSliceIteratorTest.cxx, DataRepresentation/Image/Image1.cxx, DataRepresentation/Image/Image2.cxx, DataRepresentation/Image/RGBImage.cxx, DataRepresentation/Image/VectorImage.cxx, DataRepresentation/Mesh/PointSet1.cxx, DataRepresentation/Mesh/PointSet2.cxx, DataRepresentation/Mesh/PointSet3.cxx, DataRepresentation/Mesh/PointSetWithCovariantVectors.cxx, DataRepresentation/Mesh/PointSetWithVectors.cxx, DataRepresentation/Mesh/RGBPointSet.cxx, Examples/Iterators/ImageLinearIteratorWithIndex.cxx, Iterators/ImageRegionIterator.cxx, Iterators/ImageRegionIteratorWithIndex.cxx, and Testing/Code/Common/itkVectorImageTest.cxx.

Referenced by itk::BSplineDerivativeKernelFunction< VSplineOrder >::BSplineDerivativeKernelFunction(), itk::CannySegmentationLevelSetFunction< TImageType, TFeatureImageType >::CannySegmentationLevelSetFunction(), itk::CopyMeshToMeshCellData(), itk::CopyMeshToMeshPointData(), itk::CurvatureAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >::CurvatureAnisotropicDiffusionImageFilter(), itk::DenseFiniteDifferenceImageFilter< TDeformationField, TDeformationField >::DenseFiniteDifferenceImageFilter(), itk::ShapeLabelObject< TLabel, VImageDimension >::GetBinaryPrincipalAxesToPhysicalAxesTransform(), itk::TransformFactoryBase::GetFactory(), itk::SpatialObjectFactoryBase::GetFactory(), itk::IdentityTransform< TScalarType, NDimensions >::GetInverseTransform(), itk::ShapeLabelObject< TLabel, VImageDimension >::GetPhysicalAxesToBinaryPrincipalAxesTransform(), itk::StatisticsLabelObject< TLabel, VImageDimension >::GetPhysicalAxesToPrincipalAxesTransform(), itk::StatisticsLabelObject< TLabel, VImageDimension >::GetPrincipalAxesToPhysicalAxesTransform(), itk::GradientAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >::GradientAnisotropicDiffusionImageFilter(), itk::LabelGeometryImageFilter< TLabelImage, TIntensityImage >::LabelGeometry::LabelGeometry(), itk::LabelStatisticsImageFilter< TInputImage, TLabelImage >::LabelStatistics::LabelStatistics(), itk::QuadEdgeMeshEulerOperatorSplitEdgeFunction< TMesh, TQEType >::QuadEdgeMeshEulerOperatorSplitEdgeFunction(), itk::RandomPermutation::RandomPermutation(), itk::VTKImageIOFactory::RegisterOneFactory(), itk::VTKImageIO2Factory::RegisterOneFactory(), itk::VoxBoCUBImageIOFactory::RegisterOneFactory(), itk::TxtTransformIOFactory::RegisterOneFactory(), itk::TIFFImageIOFactory::RegisterOneFactory(), itk::StimulateImageIOFactory::RegisterOneFactory(), itk::SiemensVisionImageIOFactory::RegisterOneFactory(), itk::RawImageIOFactory< TPixel, VImageDimension >::RegisterOneFactory(), itk::PNGImageIOFactory::RegisterOneFactory(), itk::PhilipsRECImageIOFactory::RegisterOneFactory(), itk::NrrdImageIOFactory::RegisterOneFactory(), itk::NiftiImageIOFactory::RegisterOneFactory(), itk::MRCImageIOFactory::RegisterOneFactory(), itk::MINC2ImageIOFactory::RegisterOneFactory(), itk::MetaImageIOFactory::RegisterOneFactory(), itk::MatlabTransformIOFactory::RegisterOneFactory(), itk::LSMImageIOFactory::RegisterOneFactory(), itk::JPEGImageIOFactory::RegisterOneFactory(), itk::GiplImageIOFactory::RegisterOneFactory(), itk::GEAdwImageIOFactory::RegisterOneFactory(), itk::GE5ImageIOFactory::RegisterOneFactory(), itk::GE4ImageIOFactory::RegisterOneFactory(), itk::GDCMImageIOFactory::RegisterOneFactory(), itk::DicomImageIOFactory::RegisterOneFactory(), itk::DICOMImageIO2Factory::RegisterOneFactory(), itk::Bruker2DSEQImageIOFactory::RegisterOneFactory(), itk::Brains2MaskImageIOFactory::RegisterOneFactory(), itk::BMPImageIOFactory::RegisterOneFactory(), itk::BioRadImageIOFactory::RegisterOneFactory(), itk::AnalyzeImageIOFactory::RegisterOneFactory(), itk::SpatialObjectFactory< T >::RegisterSpatialObject(), RegressionTestImage(), itk::ScalarChanAndVeseDenseLevelSetImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, TSharedData >::ScalarChanAndVeseDenseLevelSetImageFilter(), itk::ScalarChanAndVeseSparseLevelSetImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, TSharedData, TIdCell >::ScalarChanAndVeseSparseLevelSetImageFilter(), itk::SegmentationLevelSetFunction< TImageType, TFeatureImageType >::SegmentationLevelSetFunction(), itk::MultiphaseFiniteDifferenceImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, unsigned int >::SetFunctionCount(), itk::MultiphaseFiniteDifferenceImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, unsigned int >::SetLevelSet(), itk::SimplexMeshVolumeCalculator< TInputMesh >::SimplexCellVisitor::SimplexCellVisitor(), itk::SimplexMeshToTriangleMeshFilter< TInputMesh, TOutputMesh >::SimplexCellVisitor::SimplexCellVisitor(), itk::SimplexMeshAdaptTopologyFilter< TInputMesh, TOutputMesh >::SimplexCellVisitor::SimplexCellVisitor(), itk::MultiphaseSparseFiniteDifferenceImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, TIdCell >::SparseDataStruct::SparseDataStruct(), itk::SpatialObjectTreeNode< TDimension >::SpatialObjectTreeNode(), itk::VectorCurvatureAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >::VectorCurvatureAnisotropicDiffusionImageFilter(), itk::VectorGradientAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >::VectorGradientAnisotropicDiffusionImageFilter(), and itk::VectorThresholdSegmentationLevelSetFunction< TImageType, TFeatureImageType >::VectorThresholdSegmentationLevelSetFunction().

void HardConnectedComponentImageFilter::PrintSelf ( std::ostream &  os,
Indent  indent 
) const [protected]

Standard pipeline method.

Definition at line 132 of file itkHardConnectedComponentImageFilter.h.

Referenced by itk::Neighborhood< PixelType, itkGetStaticConstMacro(ImageDimension)>::Print(), itk::VectorThresholdSegmentationLevelSetFunction< TImageType, TFeatureImageType >::PrintSelf(), itk::VectorNeighborhoodOperatorImageFilter< TInputImage, TOutputImage >::PrintSelf(), itk::VectorNearestNeighborInterpolateImageFunction< TInputImage, TCoordRep >::PrintSelf(), itk::VectorInterpolateImageFunction< TInputImage, TCoordRep >::PrintSelf(), itk::VectorCurvatureNDAnisotropicDiffusionFunction< TImage >::PrintSelf(), itk::VectorAnisotropicDiffusionFunction< TImage >::PrintSelf(), itk::ThresholdSegmentationLevelSetFunction< TImageType, TFeatureImageType >::PrintSelf(), itk::TensorRelativeAnisotropyImageFilter< TInputImage, TOutputImage >::PrintSelf(), itk::TensorFractionalAnisotropyImageFilter< TInputImage, TOutputImage >::PrintSelf(), itk::SymmetricEigenAnalysisImageFilter< TInputImage, TOutputImage >::PrintSelf(), itk::SubtractConstantFromImageFilter< TInputImage, TConstant, TOutputImage >::PrintSelf(), itk::StatisticsLabelObject< TLabel, VImageDimension >::PrintSelf(), itk::SpatialObjectTreeNode< TDimension >::PrintSelf(), itk::SobelOperator< MovedGradientPixelType, itkGetStaticConstMacro(MovedImageDimension) >::PrintSelf(), itk::SobelEdgeDetectionImageFilter< TInputImage, TOutputImage >::PrintSelf(), itk::ShapeSignedDistanceFunction< TCoordRep, VSpaceDimension >::PrintSelf(), itk::ShapeLabelObject< TLabel, VImageDimension >::PrintSelf(), itk::Statistics::Sample< ImageJointDomainTraits< TImage >::MeasurementVectorType >::PrintSelf(), itk::Statistics::ProbabilityDistribution::PrintSelf(), itk::PDEDeformableRegistrationFunction< TFixedImage, TMovingImage, TDeformationField >::PrintSelf(), itk::NormalizedCorrelationImageFilter< TInputImage, TMaskImage, TOutputImage, TOperatorValueType >::PrintSelf(), itk::NeighborhoodOperatorImageFilter< TInputImage, TOutputImage, TOperatorValueType >::PrintSelf(), itk::NeighborhoodOperator< TPixel, TDimension, TAllocator >::PrintSelf(), itk::NearestNeighborInterpolateImageFunction< TInputImage, TCoordRep >::PrintSelf(), itk::NearestNeighborExtrapolateImageFunction< TInputImage, TCoordRep >::PrintSelf(), itk::MultiplyByConstantImageFilter< TInputImage, TConstant, TOutputImage >::PrintSelf(), itk::Statistics::MersenneTwisterRandomVariateGenerator::PrintSelf(), itk::Statistics::MembershipFunctionBase< TMeasurementVector >::PrintSelf(), itk::MaskNegatedImageFilter< TInputImage, TMaskImage, TOutputImage >::PrintSelf(), itk::MaskImageFilter< TInputImage, TMaskImage, TOutputImage >::PrintSelf(), itk::Statistics::ListSampleBase< ImageJointDomainTraits< TImage >::MeasurementVectorType >::PrintSelf(), itk::LaplacianOperator< TPixel, VDimension, TAllocator >::PrintSelf(), itk::KernelFunction::PrintSelf(), itk::InterpolateImageFunction< TImageType, TCoordRep >::PrintSelf(), itk::ImageKernelOperator< TPixel, VDimension, TAllocator >::PrintSelf(), itk::GeodesicActiveContourShapePriorLevelSetFunction< TImageType, TFeatureImageType >::PrintSelf(), itk::GeodesicActiveContourLevelSetFunction< TImageType, TFeatureImageType >::PrintSelf(), itk::GaussianOperator< TPixel, VDimension, TAllocator >::PrintSelf(), itk::GaussianKernelFunction::PrintSelf(), itk::GaussianDerivativeOperator< TPixel, VDimension, TAllocator >::PrintSelf(), itk::FastApproximateRankImageFilter< TInputImage, TOutputImage >::PrintSelf(), itk::ExtrapolateImageFunction< TInputImage, TCoordRep >::PrintSelf(), itk::DivideByConstantImageFilter< TInputImage, TConstant, TOutputImage >::PrintSelf(), itk::DerivativeOperator< PixelType, itkGetStaticConstMacro(ImageDimension)>::PrintSelf(), itk::Statistics::DensityFunction< TMeasurementVector >::PrintSelf(), itk::CurvesLevelSetFunction< TImageType, TFeatureImageType >::PrintSelf(), itk::Functor::ColormapFunctor< TScalar, TRGBPixel >::PrintSelf(), itk::BSplineKernelFunction< VSplineOrder >::PrintSelf(), itk::BSplineDerivativeKernelFunction< VSplineOrder >::PrintSelf(), itk::BinaryThresholdProjectionImageFilter< TInputImage, TOutputImage >::PrintSelf(), itk::BinaryProjectionImageFilter< TInputImage, TOutputImage >::PrintSelf(), itk::AreaOpeningImageFilter< TInputImage, TOutputImage, TAttribute >::PrintSelf(), itk::AreaClosingImageFilter< TInputImage, TOutputImage, TAttribute >::PrintSelf(), itk::AnnulusOperator< TPixel, TDimension, TAllocator >::PrintSelf(), itk::AnisotropicDiffusionFunction< TImage >::PrintSelf(), itk::AddConstantToImageFilter< TInputImage, TConstant, TOutputImage >::PrintSelf(), and itk::ActiveShapeModelCalculator< TImage >::PrintSelf().

void HardConnectedComponentImageFilter::SetObjectSeed ( const IndexType &  seed  ) 

Setting the seed points for specified object.

Definition at line 102 of file itkHardConnectedComponentImageFilter.h.

References m_Seeds.

virtual HardConnectedComponentImageFilter::~HardConnectedComponentImageFilter (  )  [protected, virtual]

Definition at line 125 of file itkHardConnectedComponentImageFilter.h.


Variable Documentation

const unsigned int HardConnectedComponentImageFilter::ImageDimension = TOutputImage::ImageDimension [static]

Extract some information from the image types. Dimensionality of the two images is assumed to be the same.

Examples:
Common/itkImageSliceIteratorTest.cxx.

Definition at line 72 of file itkHardConnectedComponentImageFilter.h.

Referenced by itk::BilateralImageFilter< TInputImage, TOutputImage >::BilateralImageFilter(), itk::BoxAccumulateFunction(), itk::BoxMeanCalculatorFunction(), itk::BoxSigmaCalculatorFunction(), itk::BoxSquareAccumulateFunction(), itk::Statistics::JointDomainImageToListAdaptor< TImage >::ComputeRegion(), itk::CornerOffsets(), itk::DiscreteGaussianDerivativeImageFilter< TInputImage, TOutputImage >::DiscreteGaussianDerivativeImageFilter(), itk::DiscreteGaussianImageFilter< TInputImage, TOutputImage >::DiscreteGaussianImageFilter(), itk::BSplineInterpolateImageFunction< TImageType, TCoordRep, TImageType::PixelType >::EvaluateAtContinuousIndex(), itk::NearestNeighborExtrapolateImageFunction< TInputImage, TCoordRep >::EvaluateAtContinuousIndex(), itk::NearestNeighborExtrapolateImageFunction< TInputImage, TCoordRep >::EvaluateAtIndex(), itk::VectorGradientMagnitudeImageFilter< TInputImage, TRealType, TOutputImage >::EvaluateAtNeighborhood(), itk::VectorGradientMagnitudeImageFilter< TInputImage, TRealType, TOutputImage >::EvaluateAtNeighborhood3D(), itk::BSplineInterpolateImageFunction< TImageType, TCoordRep, TImageType::PixelType >::EvaluateDerivativeAtContinuousIndex(), itk::BSplineInterpolateImageFunction< TImageType, TCoordRep, TImageType::PixelType >::EvaluateValueAndDerivativeAtContinuousIndex(), itk::FiniteDifferenceFunction< TSparseImageType >::FiniteDifferenceFunction(), itk::AreaOpeningImageFilter< TInputImage, TOutputImage, TAttribute >::GenerateData(), itk::AreaClosingImageFilter< TInputImage, TOutputImage, TAttribute >::GenerateData(), itk::ImageRegion< TDimension >::GetImageDimension(), itk::ImageConstIteratorWithIndex< TImageType >::GetImageDimension(), itk::PathConstIterator< TImage, TPath >::GetImageIteratorDimension(), itk::LineConstIterator< TImage >::GetImageIteratorDimension(), itk::ImageReverseConstIterator< TImage >::GetImageIteratorDimension(), itk::ShapedFloodFilledFunctionConditionalConstIterator< TImage, TFunction >::GetIteratorDimension(), itk::FloodFilledFunctionConditionalConstIterator< TImage, TFunction >::GetIteratorDimension(), itk::ConditionalConstIterator< TImage >::GetIteratorDimension(), itk::Statistics::JointDomainImageToListAdaptor< TImage >::GetMeasurementVector(), itk::SparseFieldFourthOrderLevelSetImageFilter< TInputImage, TOutputImage >::GetMinimumNumberOfLayers(), itk::StatisticsLabelObject< TLabel, VImageDimension >::GetPhysicalAxesToPrincipalAxesTransform(), itk::StatisticsLabelObject< TLabel, VImageDimension >::GetPrincipalAxesToPhysicalAxesTransform(), itk::ImageReverseConstIterator< TImage >::ImageReverseConstIterator(), itk::RegionBasedLevelSetFunction< TInputImage, TFeatureImage, TSharedData >::Initialize(), itk::VectorCurvatureAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >::InitializeIteration(), itk::CurvatureAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >::InitializeIteration(), itk::ImageRegion< TDimension >::IsInside(), itk::ImageFunction< TInputImage, TOutput, TOutput >::IsInsideBuffer(), itk::LabelGeometryImageFilter< TLabelImage, TIntensityImage >::LabelGeometry::LabelGeometry(), itk::LabelStatisticsImageFilter< TInputImage, TLabelImage >::LabelStatistics::LabelStatistics(), itk::ImageLinearConstIteratorWithIndex< TImage >::NextLine(), itk::VectorGradientMagnitudeImageFilter< TInputImage, TRealType, TOutputImage >::NonPCEvaluateAtNeighborhood(), itk::Functor::LabelObjectLineComparator< TLabelObjectLine >::operator()(), itk::ImageReverseConstIterator< TImage >::operator=(), itk::ImageLinearConstIteratorWithIndex< TImage >::PreviousLine(), itk::ImageLinearConstIteratorWithIndex< TImageType >::SetDirection(), itk::RegionBasedLevelSetFunction< TInputImage, TFeatureImage, TSharedData >::SetFeatureImage(), itk::DiscreteGaussianImageFilter< TInputImage, TOutputImage >::SetMaximumError(), itk::CannyEdgeDetectionImageFilter< ImageType, ImageType >::SetMaximumError(), itk::SumOfSquaresImageFunction< TInputImage, TCoordRep >::SetNeighborhoodRadius(), itk::FastApproximateRankImageFilter< TInputImage, TOutputImage >::SetRank(), itk::DiscreteGaussianImageFilter< TInputImage, TOutputImage >::SetVariance(), itk::CannyEdgeDetectionImageFilter< ImageType, ImageType >::SetVariance(), and itk::ShapeUniqueLabelMapFilter< TImage >::TemplatedGenerateData().

const unsigned int HardConnectedComponentImageFilter::InputImageDimension = TInputImage::ImageDimension [static]

Extract some information from the image types. Dimensionality of the two images is assumed to be the same.

Definition at line 70 of file itkHardConnectedComponentImageFilter.h.

Referenced by itk::MRFImageFilter< TInputImage, TClassifiedImage >::GetNeighborhoodRadius().


Generated at Mon Jul 12 2010 20:21:07 for ITK by doxygen 1.7.1 written by Dimitri van Heesch, © 1997-2000