ITK  4.1.0
Insight Segmentation and Registration Toolkit
Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
itk::AbortCheckEvent
itk::AbortEvent
itk::Functor::Abs< TInput, TOutput >Computes the absolute value of a pixel
itk::AbsImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_abs() of its pixels
itk::AbsImageFilter< TInputImage, TOutputImage >Computes the absolute value of each pixel
itk::HessianToObjectnessMeasureImageFilter< TInputImage, TOutputImage >::AbsLessEqualCompareReturns ( abs(a) <= abs(b) )
itk::Functor::AbsoluteValueDifference2< TInput1, TInput2, TOutput >
itk::AbsoluteValueDifferenceImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements pixel-wise the computation of absolute value difference
itk::Accessor::AbsPixelAccessor< TInternalType, TExternalType >Give access to the vcl_abs() function of a value
itk::Functor::AccessorFunctor< TInput, TAccessor >Convert an accessor to a functor so that it can be used in a UnaryFunctorImageFilter
itk::AccumulateImageFilter< TInputImage, TOutputImage >Implements an accumulation of an image along a selected direction
itk::Functor::Acos< TInput, TOutput >Computes the Acos of a pixel
itk::AcosImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_acos() of its pixels
itk::AcosImageFilter< TInputImage, TOutputImage >Computes the inverse cosine of each pixel
itk::Accessor::AcosPixelAccessor< TInternalType, TExternalType >Give access to the vcl_acos() function of a value
itk::AdaptImageFilter< TInputImage, TOutputImage, TAccessor >Convert an image to another pixel type using the specified data accessor
itk::AdaptiveHistogramEqualizationImageFilter< TImageType >Power Law Adaptive Histogram Equalization
itk::Functor::Add1< TInput, TOutput >
itk::Functor::Add2< TInput1, TInput2, TOutput >
itk::Functor::Add3< TInput1, TInput2, TInput3, TOutput >
itk::AddConstantToImageFilter< TInputImage, TConstant, TOutputImage >Add a constant to all input pixels
itk::AddImageAdaptor< TImage >Presents an image as being the addition of a constant value to all pixels
itk::AddImageFilter< TInputImage1, TInputImage2, TOutputImage >Pixel-wise addition of two images
itk::Concept::AdditiveAndAssignOperators< T1, T2 >
itk::Concept::AdditiveOperators< T1, T2, T3 >
itk::LaplacianRecursiveGaussianImageFilter< TInputImage, TOutputImage >::AddMultConstFunctor
itk::Accessor::AddPixelAccessor< TPixel >Simulates the effect of adding a constant value to all pixels
itk::AffineGeometryFrame< TScalarType, NDimensions >Describes the geometry of a data object
itk::AffineTransform< TScalarType, NDimensions >
itk::AggregateLabelMapFilter< TImage >Collapses all labels into the first label
itk::AmoebaOptimizerWrap of the vnl_amoeba algorithm
itk::AnalyzeImageIOClass that defines how to read Analyze file format. Analyze IMAGE FILE FORMAT - As much information as I can determine from the Medical image formats web site, and the Analyze75.pdf file provided from the Mayo clinic. A special note of thanks to Dennis P. Hanson (dph@mayo.edu) for his generous contributions in getting this information correct
itk::AnalyzeImageIOFactoryCreate instances of AnalyzeImageIO objects using an object factory
itk::AnchorCloseImageFilter< TImage, TKernel >
itk::AnchorDilateImageFilter< TImage, TKernel >
itk::AnchorErodeDilateImageFilter< TImage, TKernel, TFunction1 >Class to implement erosions and dilations using anchor methods. This is the base class that must be instantiated with appropriate definitions of greater, less and so on. The SetBoundary facility isn't necessary for operation of the anchor method but is included for compatability with other morphology classes in itk
itk::AnchorErodeDilateLine< TInputPix, TCompare >Class to implement erosions and dilations using anchor methods. This is the base class that must be instantiated with appropriate definitions of greater, less and so on. There is special code for cases where the structuring element is bigger than the image size that aren't particularly anchor related, but use the same data structures. Hopefully these sections occupy a very minor proportion of the time
itk::AnchorErodeImageFilter< TImage, TKernel >
itk::AnchorOpenCloseImageFilter< TImage, TKernel, TCompare1, TCompare2 >Class to implement openings and closings using anchor methods
itk::AnchorOpenCloseLine< TInputPix, TCompare >Class to implement openings and closings using anchor methods. This is the base class that must be instantiated with appropriate definitions of greater, less and so on
itk::AnchorOpenImageFilter< TImage, TKernel >
AnchorUtilitiesFunctionality in common for anchor openings/closings and erosions/dilation
itk::Functor::AND< TInput1, TInput2, TOutput >
itk::AndImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements the AND logical operator pixel-wise between two images
itk::AnisotropicDiffusionFunction< TImage >
itk::AnisotropicDiffusionImageFilter< TInputImage, TOutputImage >
itk::AnisotropicFourthOrderLevelSetImageFilter< TInputImage, TOutputImage >This class implements the 4th-order level set anisotropic diffusion (smoothing) PDE
itk::AnnulusOperator< TPixel, TDimension, TAllocator >A NeighborhoodOperator for performing a matched filtering with an annulus (two concentric circles, spheres, hyperspheres, etc.)
itk::AntiAliasBinaryImageFilter< TInputImage, TOutputImage >A method for estimation of a surface from a binary volume
itk::ANTSNeighborhoodCorrelationImageToImageMetricv4< TFixedImage, TMovingImage, TVirtualImage >Computes normalized cross correlation using a small neighborhood for each voxel between two images, with speed optimizations for dense registration
itk::ANTSNeighborhoodCorrelationImageToImageMetricv4DenseGetValueAndDerivativeThreader< TImageToImageMetric, TNeighborhoodCorrelationMetric >Processes points for NeighborhoodScanningWindow calculation
itk::AnyEvent
itk::ApproximateSignedDistanceMapImageFilter< TInputImage, TOutputImage >Create a map of the approximate signed distance from the boundaries of a binary image
itk::ArchetypeSeriesFileNamesGenerate an ordered sequence of filenames
itk::AreaClosingImageFilter< TInputImage, TOutputImage, TAttribute >Morphological closing by attributes
itk::AreaOpeningImageFilter< TInputImage, TOutputImage, TAttribute >Morphological opening by attributes
itk::Array< TValueType >Array class with size defined at construction time
itk::Array2D< TValueType >Array2D class representing a 2D array with size defined at construction time
itk::ArrowSpatialObject< TDimension >Representation of a Arrow based on the spatial object classes
itk::Functor::Asin< TInput, TOutput >
itk::AsinImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_asin() of its pixels
itk::AsinImageFilter< TInputImage, TOutputImage >Computes the sine of each pixel
itk::Accessor::AsinPixelAccessor< TInternalType, TExternalType >Give access to the vcl_asin() function of a value
itk::Concept::Assignable< T >
itk::Functor::Atan< TInput, TOutput >
itk::Functor::Atan2< TInput1, TInput2, TOutput >
itk::Atan2ImageFilter< TInputImage1, TInputImage2, TOutputImage >Computes two argument inverse tangent
itk::AtanImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_atan() of its pixels
itk::AtanImageFilter< TInputImage, TOutputImage >Computes the one-argument inverse tangent of each pixel
itk::Accessor::AtanPixelAccessor< TInternalType, TExternalType >Give access to the vcl_atan() function of a value
itk::AtanRegularizedHeavisideStepFunction< TInput, TOutput >Atan-based implementation of the Regularized (smoothed) Heaviside functions
itk::AttributeKeepNObjectsLabelMapFilter< TImage, TAttributeAccessor >Keep N objects according to their attribute value
itk::AttributeLabelObject< TLabel, VImageDimension, TAttributeValue >A LabelObject with a generic attribute
itk::Functor::AttributeLabelObjectAccessor< TLabelObject >
itk::AttributeMorphologyBaseImageFilter< TInputImage, TOutputImage, TAttribute, TFunction >Morphological opening by attributes
itk::AttributeOpeningLabelMapFilter< TImage, TAttributeAccessor >Remove the objects according to the value of their attribute
itk::AttributePositionLabelMapFilter< TImage, TAttributeAccessor, VPhysicalPosition >Mark a single pixel in the label object which correspond to a position given by an attribute
itk::AttributeRelabelLabelMapFilter< TImage, TAttributeAccessor >Relabel objects according to their shape attributes
itk::AttributeSelectionLabelMapFilter< TImage, TAttributeAccessor >Remove the objects according to the value of their attribute
itk::AttributeUniqueLabelMapFilter< TImage, TAttributeAccessor >Make sure that the objects are not overlapping
itk::AuthalicMatrixCoefficients< TInputMesh >Compute a matrix filled with Authalic Coefiicients of the edge, wherever two vertices are connected with an edge
itk::AutoCropLabelMapFilter< TInputImage >Crop a LabelMap image to fit exactly the objects in the LabelMap
itk::AutomaticTopologyMeshSource< TOutputMesh >Convenience class for generating meshes
itk::AutoPointer< TObjectType >Implements an Automatic Pointer to an object
itk::AutoPointerDataObjectDecorator< T >Decorates any pointer to a simple object with a DataObject API using AutoPointer semantics
itk::Function::AutumnColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::AuxVarTypeDefault< TPixel, VAuxDimension, VSetDimension >Level set auxiliary variables type information
itk::FastMarchingImageFilter< TLevelSet, TSpeedImage >::AxisNodeType
itk::AzimuthElevationToCartesianTransform< TScalarType, NDimensions >Transforms from an azimuth, elevation, radius coordinate system to a Cartesian coordinate system, or vice versa
itk::Statistics::BackPropagationLayer< TMeasurementVector, TTargetVector >This is the itkBackPropagationLayer class
itk::BackwardDifferenceOperator< TPixel, TDimension, TAllocator >Operator whose inner product with a neighborhood returns a "half" derivative at the center of the neighborhood
itk::BalloonForceFilter< TInputMesh, TOutputMesh >BalloonForceFilter is used to apply balloon force and the potential force onto the 2D surface model embedded in a 3D space
itk::BandNode< TIndexType, TDataType >
itk::BarrierStandard barrier class implementation for synchronizing the execution of threads
itk::BarycentricCombination< TPointContainer, TWeightContainer >Computes the barycentric combination of an array of N points
itk::BasicDilateImageFilter< TInputImage, TOutputImage, TKernel >Gray scale dilation of an image
itk::BasicErodeImageFilter< TInputImage, TOutputImage, TKernel >Gray scale erosion of an image
itk::Statistics::BatchSupervisedTrainingFunction< TSample, TTargetVector, ScalarType >This is the itkBatchSupervisedTrainingFunction class
itk::BayesianClassifierImageFilter< TInputVectorImage, TLabelsType, TPosteriorsPrecisionType, TPriorsPrecisionType >Performs Bayesian Classification on an image
itk::BayesianClassifierInitializationImageFilter< TInputImage, TProbabilityPrecisionType >This filter is intended to be used as a helper class to initialize the BayesianClassifierImageFilter
itk::BilateralImageFilter< TInputImage, TOutputImage >Blurs an image while preserving edges
itk::Functor::BinaryAccumulator< TInputPixel, TOutputPixel >
itk::BinaryBallStructuringElement< TPixel, VDimension, TAllocator >A Neighborhood that represents a ball structuring element (ellipsoid) with binary elements
itk::ImageToImageFilterDetail::BinaryBooleanDispatch< B1, B2 >Templated class to produce a unique type for a pairing of booleans
itk::BinaryClosingByReconstructionImageFilter< TInputImage, TKernel >Binary closing by reconstruction of an image
itk::BinaryContourImageFilter< TInputImage, TOutputImage >Labels the pixels on the border of the objects in a binary image
itk::BinaryCrossStructuringElement< TPixel, VDimension, TAllocator >A Neighborhood that represents a cross structuring element with binary elements
itk::BinaryDilateImageFilter< TInputImage, TOutputImage, TKernel >Fast binary dilation
itk::BinaryErodeImageFilter< TInputImage, TOutputImage, TKernel >Fast binary erosion
itk::BinaryFillholeImageFilter< TInputImage >Remove holes not connected to the boundary of the image
itk::BinaryFunctorImageFilter< TInputImage1, TInputImage2, TOutputImage, TFunction >Implements pixel-wise generic operation of two images, or of an image and a constant
itk::BinaryGrindPeakImageFilter< TInputImage >Remove the objects not connected to the boundary of the image
itk::BinaryImageToLabelMapFilter< TInputImage, TOutputImage >Label the connected components in a binary image and produce a collection of label objects
itk::BinaryImageToLevelSetImageAdaptor< TInputImage, TLevelSet >
itk::BinaryImageToLevelSetImageAdaptor< TInput, MalcolmSparseLevelSetImage< TInput::ImageDimension > >
itk::BinaryImageToLevelSetImageAdaptor< TInput, ShiSparseLevelSetImage< TInput::ImageDimension > >
itk::BinaryImageToLevelSetImageAdaptor< TInput, WhitakerSparseLevelSetImage< TOutput, TInput::ImageDimension > >
itk::BinaryImageToLevelSetImageAdaptor< TInputImage, LevelSetDenseImageBase< TLevelSetImage > >
itk::BinaryImageToLevelSetImageAdaptorBase< TInputImage, TLevelSet >
itk::BinaryImageToShapeLabelMapFilter< TInputImage, TOutputImage >Converts a binary image to a label map and valuate the shape attributes
itk::BinaryImageToSparseLevelSetImageAdaptorBase< TInput, TOutput >
itk::BinaryImageToStatisticsLabelMapFilter< TInputImage, TFeatureImage, TOutputImage >Convenient class to convert a binary image to a label map and valuate the statistics attributes at once
itk::ImageToImageFilterDetail::BinaryIntDispatch< D1, D2 >Templated class to produce a unique type for a pairing of integers
itk::BinaryMagnitudeImageFilter< TInputImage1, TInputImage2, TOutputImage >Computes the square root of the sum of squares of corresponding input pixels
itk::BinaryMask3DMeshSource< TInputImage, TOutputMesh >
itk::BinaryMaskToNarrowBandPointSetFilter< TInputImage, TOutputMesh >Generate a PointSet containing the narrow band around the edges of a input binary image
itk::BinaryMedianImageFilter< TInputImage, TOutputImage >Applies a version of the median filter optimized for binary images
itk::BinaryMinMaxCurvatureFlowFunction< TImage >
itk::BinaryMinMaxCurvatureFlowImageFilter< TInputImage, TOutputImage >Denoise a binary image using min/max curvature flow
itk::BinaryMorphologicalClosingImageFilter< TInputImage, TOutputImage, TKernel >Binary morphological closing of an image
itk::BinaryMorphologicalOpeningImageFilter< TInputImage, TOutputImage, TKernel >Binary morphological opening of an image
itk::BinaryMorphologyImageFilter< TInputImage, TOutputImage, TKernel >Base class for fast binary dilation and erosion
itk::Functor::BinaryNot< TPixel >
itk::BinaryNotImageFilter< TImage >Implements the BinaryNot logical operator pixel-wise between two images
itk::BinaryOpeningByReconstructionImageFilter< TInputImage, TKernel >Binary morphological closing of an image
itk::BinaryProjectionImageFilter< TInputImage, TOutputImage >Binary projection
itk::BinaryPruningImageFilter< TInputImage, TOutputImage >This filter removes "spurs" of less than a certain length in the input image
itk::BinaryReconstructionByDilationImageFilter< TInputImage >Binary reconstruction by dilation of an image
itk::BinaryReconstructionByErosionImageFilter< TInputImage >Binary reconstruction by erosion of an image
itk::BinaryReconstructionLabelMapFilter< TImage, TMarkerImage, TAttributeAccessor >Mark the objects at least partially at the same position as the objects in a binary image
itk::BinaryShapeKeepNObjectsImageFilter< TInputImage >Keep N objects according to their shape attributes
itk::BinaryShapeOpeningImageFilter< TInputImage >Remove objects based on the value of their shape attribute
itk::BinaryStatisticsKeepNObjectsImageFilter< TInputImage, TFeatureImage >Keep N objects according to their statistics attributes
itk::BinaryStatisticsOpeningImageFilter< TInputImage, TFeatureImage >Remove objects based on the value of their Statistics attribute
itk::BinaryThinningImageFilter< TInputImage, TOutputImage >This filter computes one-pixel-wide edges of the input image
itk::Functor::BinaryThreshold< TInput, TOutput >
itk::Function::BinaryThresholdAccumulator< TInputPixel, TOutputPixel >
itk::BinaryThresholdImageFilter< TInputImage, TOutputImage >Binarize an input image by thresholding
itk::BinaryThresholdImageFunction< TInputImage, TCoordRep >Returns true is the value of an image lies within a range of thresholds This ImageFunction returns true (or false) if the pixel value lies within (outside) a lower and upper threshold value. The threshold range can be set with the ThresholdBelow, ThresholdBetween or ThresholdAbove methods. The input image is set via method SetInputImage()
itk::BinaryThresholdProjectionImageFilter< TInputImage, TOutputImage >BinaryThreshold projection
itk::BinaryThresholdSpatialFunction< TFunction >A spatial functions that returns if the internal spatial function is within user specified thresholds
itk::ImageToImageFilterDetail::BinaryUnsignedIntDispatch< D1, D2 >Templated class to produce a unique type for a pairing of unsigned integers (usually two dimensions)
itk::BinomialBlurImageFilter< TInputImage, TOutputImage >Performs a separable blur on each dimension of an image
itk::BioRadImageIOImageIO class for reading Bio-Rad images. Bio-Rad file format are used by confocal micropscopes like MRC 1024, MRC 600 http://www.bio-rad.com/
itk::BioRadImageIOFactoryCreate instances of BioRadImageIO objects using an object factory
itk::Function::BlackmanWindowFunction< VRadius, TInput, TOutput >Window function for sinc interpolation.

\[ w(x) = 0.42 + 0.5 cos(\frac{\pi x}{m}) + 0.08 cos(\frac{2 \pi x}{m}) \]

itk::BlackTopHatImageFilter< TInputImage, TOutputImage, TKernel >Black top hat extract local minima that are smaller than the structuring element
itk::BlobSpatialObject< TDimension >Spatial object representing a potentially amorphous object
itk::Function::BlueColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::BluePixelAccessor< T >Give access to the Blue component of a RGBPixel type
itk::BMPImageIORead BMPImage file format
itk::BMPImageIOFactoryCreate instances of BMPImageIO objects using an object factory
itk::ImageToImageFilterDetail::BooleanDispatch< bool >Templated class to produce a unique type "true" and "false"
itk::BorderQuadEdgeMeshFilter< TInputMesh, TOutputMesh >Transform one border of a QuadEdgeMesh into either a circle (conformal) or a square (arclength-wise)
itk::watershed::Boundary< TScalarType, TDimension >
itk::Mesh< TPixelType, VDimension, TMeshTraits >::BoundaryAssignmentIdentifier
itk::watershed::BoundaryResolver< TPixelType, TDimension >
itk::Functor::BoundedReciprocal< TInput, TOutput >
itk::BoundedReciprocalImageFilter< TInputImage, TOutputImage >Computes 1/(1+x) for each pixel in the image
itk::BoundingBox< TPointIdentifier, VPointDimension, TCoordRep, TPointsContainer >Represent and compute information about bounding boxes
itk::Functor::BoundingBoxLabelObjectAccessor< TLabelObject >
itk::BoxImageFilter< TInputImage, TOutputImage >A base class for all the filters working on a box neighborhood
itk::BoxMeanImageFilter< TInputImage, TOutputImage >Implements a fast rectangular mean filter using the accumulator approach
itk::BoxSigmaImageFilter< TInputImage, TOutputImage >Implements a fast rectangular sigma filter using the accumulator approach
itk::BoxSpatialObject< TDimension >The class may be used to represent N-dimensional boxes. In two dimensions it is a rectangle, In three dimensions it is a cuboid..
itk::Concept::BracketOperator< T1, T2, T3 >
itk::BresenhamLine< VDimension >
itk::Bruker2DSEQImageIOClass that defines how to read Bruker file format. Bruker IMAGE FILE FORMAT - The following is a brief description of the Bruker file format taken from:
itk::Bruker2DSEQImageIOFactoryCreate instances of Bruker2DSEQImageIO objects using an object factory
itk::BSplineBaseTransform< TScalarType, NDimensions, VSplineOrder >A base class with common elements of BSplineTransform and BSplineDeformableTransform
itk::BSplineCenteredL2ResampleImageFilterBase< TInputImage, TOutputImage >
itk::BSplineCenteredResampleImageFilterBase< TInputImage, TOutputImage >Evaluates the Centered B-Spline interpolation of an image. Spline order may be from 0 to 5
itk::BSplineControlPointImageFilter< TInputImage, TOutputImage >Process a given a B-spline grid of control points
itk::BSplineControlPointImageFunction< TInputImage, TCoordRep >Evaluate a B-spline object given a grid of control points
itk::BSplineDecompositionImageFilter< TInputImage, TOutputImage >Calculates the B-Spline coefficients of an image. Spline order may be from 0 to 5
itk::BSplineDeformableTransform< TScalarType, NDimensions, VSplineOrder >Deformable transform using a BSpline representation
itk::BSplineDerivativeKernelFunction< VSplineOrder, TRealValueType >Derivative of a BSpline kernel used for density estimation and nonparameteric regression
itk::BSplineDownsampleImageFilter< TInputImage, TOutputImage, ResamplerType >Down-samples an image by a factor of 2 using B-Spline filter interpolation
itk::BSplineInterpolateImageFunction< TImageType, TCoordRep, TCoefficientType >Evaluates the B-Spline interpolation of an image. Spline order may be from 0 to 5
itk::BSplineInterpolationWeightFunction< TCoordRep, VSpaceDimension, VSplineOrder >Returns the weights over the support region used for B-spline interpolation/reconstruction
itk::BSplineKernelFunction< VSplineOrder, TRealValueType >BSpline kernel used for density estimation and nonparameteric regression
itk::BSplineL2ResampleImageFilterBase< TInputImage, TOutputImage >Uses the "Centered l2" B-Spline pyramid implementation of B-Spline Filters to up/down sample an image by a factor of 2
itk::BSplineResampleImageFilterBase< TInputImage, TOutputImage >Uses the "l2" spline pyramid implementation of B-Spline Filters to up/down sample an image by a factor of 2
itk::BSplineResampleImageFunction< TImageType, TCoordRep >Resample image intensity from a BSpline coefficient image
itk::BSplineScatteredDataPointSetToImageFilter< TInputPointSet, TOutputImage >Image filter which provides a B-spline output approximation
itk::BSplineSmoothingOnUpdateDisplacementFieldTransform< TScalar, NDimensions >Representation of a smooth deformation field with B-splines
itk::BSplineSmoothingOnUpdateDisplacementFieldTransformParametersAdaptor< TTransform >Helper class for multiresolution image registration
itk::BSplineTransform< TScalarType, NDimensions, VSplineOrder >Deformable transform using a BSpline representation
itk::BSplineTransformInitializer< TTransform, TImage >BSplineTransformInitializer is a helper class intended to initialize the control point grid such that it has a physically consistent definition
itk::BSplineTransformParametersAdaptor< TTransform >BSplineTransformParametersAdaptor adapts a BSplineTransform to the new specified fixed parameters
itk::BSplineUpsampleImageFilter< TInputImage, TOutputImage, ResamplerType >Uses B-Spline interpolation to upsample an image by a factor of 2. This class is the public interface for spline upsampling as defined by the ResamplerType
itk::ByteSwapper< T >Perform machine dependent byte swapping
itk::BYUMeshIOThis class defines how to read and write BYU Geometry File Format
itk::BYUMeshIOFactoryCreate instances of BYUMeshIO objects using an object factory
itk::NeighborhoodAlgorithm::CalculateOutputWrapOffsetModifiers< TImage >Sets up itkNeighborhoodIterator output buffers
itk::VTKImageExportBase::CallbackTypeProxyProvide compatibility between VTK 4.4 and earlier versions
itk::Statistics::KdTreeBasedKmeansEstimator< TKdTree >::CandidateVector::Candidate
itk::Statistics::KdTreeBasedKmeansEstimator< TKdTree >::CandidateVectorCandidate Vector
itk::CannyEdgeDetectionImageFilter< TInputImage, TOutputImage >This filter is an implementation of a Canny edge detector for scalar-valued images. Based on John Canny's paper "A Computational Approach to Edge Detection"(IEEE Transactions on Pattern Analysis and Machine Intelligence, Vol. PAMI-8, No.6, November 1986), there are four major steps used in the edge-detection scheme: (1) Smooth the input image with Gaussian filter. (2) Calculate the second directional derivatives of the smoothed image. (3) Non-Maximum Suppression: the zero-crossings of 2nd derivative are found, and the sign of third derivative is used to find the correct extrema. (4) The hysteresis thresholding is applied to the gradient magnitude (multiplied with zero-crossings) of the smoothed image to find and link edges
itk::CannySegmentationLevelSetFunction< TImageType, TFeatureImageType >A refinement of the standard level-set function which computes a speed term and advection term based on pseudo-Canny edges. See CannySegmentationLevelSetImageFilter for complete information
itk::CannySegmentationLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on image features derived from pseudo-canny-edges
itk::CannyEdgeDetectionImageFilter< TInputImage, TOutputImage >::CannyThreadStruct
itk::Functor::Cast< TInput, TOutput >
itk::CastImageFilter< TInputImage, TOutputImage >Casts input pixels to output pixel type
itk::bio::Cell< NSpaceDimension >This class implements the minimal behavior of a biological cell
itk::bio::CellBaseNon-templated Base class from which the templated Cell classes will be derived
itk::CellInterface< TPixelType, TCellTraits >An abstract interface for cells
itk::CellInterfaceVisitor< TPixelType, TCellTraits >Abstract interface for a visitor class that can visit the cells in a Mesh
itk::CellInterfaceVisitorImplementation< TPixelType, TCellTraits, CellTopology, UserVisitor >A template class used to implement a visitor object
itk::CellTraitsInfo< VPointDimension, TCoordRep, TInterpolationWeight, TPointIdentifier, TCellIdentifier, TCellFeatureIdentifier, TPoint, TPointsContainer, TUsingCellsContainer >A simple utility class to define the cell type inside a mesh type structure definition. This just makes a copy of existing type information that is needed for a cell type template parameter
itk::bio::CellularAggregate< NSpaceDimension >Base class for different types of cellular groups, including bacterial colonies and pluricellular organisms
itk::bio::CellularAggregateBaseBase class for the CellularAggregates
itk::CenteredAffineTransform< TScalarType, NDimensions >Affine transformation with a specified center of rotation
itk::CenteredEuler3DTransform< TScalarType >CenteredEuler3DTransform of a vector space (e.g. space coordinates)
itk::CenteredRigid2DTransform< TScalarType >CenteredRigid2DTransform of a vector space (e.g. space coordinates)
itk::CenteredSimilarity2DTransform< TScalarType >CenteredSimilarity2DTransform of a vector space (e.g. space coordinates)
itk::CenteredTransformInitializer< TTransform, TFixedImage, TMovingImage >CenteredTransformInitializer is a helper class intended to initialize the center of rotation and the translation of Transforms having the center of rotation among their parameters
itk::CenteredVersorTransformInitializer< TFixedImage, TMovingImage >CenteredVersorTransformInitializer is a helper class intended to initialize the center of rotation, versor, and translation of the VersorRigid3DTransform
itk::Functor::CenterOfGravityLabelObjectAccessor< TLabelObject >
itk::CentralDifferenceImageFunction< TInputImage, TCoordRep >Calculate the derivative by central differencing
itk::Functor::CentroidLabelObjectAccessor< TLabelObject >
itk::ChainCodePath< VDimension >Represent a path as a sequence of connected image index offsets
itk::ChainCodePath2DRepresent a 2D path as a sequence of connected image index offsets
itk::ChainCodeToFourierSeriesPathFilter< TInputChainCodePath, TOutputFourierSeriesPath >Filter that produces a Fourier series version of a chain code path
itk::ChangeInformationImageFilter< TInputImage >Change the origin, spacing and/or region of an Image
itk::Functor::ChangeLabel< TInput, TOutput >
itk::ChangeLabelImageFilter< TInputImage, TOutputImage >Change Sets of Labels
itk::ChangeLabelLabelMapFilter< TImage >Replace the label Ids of selected LabelObjects with new label Ids
itk::ChangeRegionLabelMapFilter< TInputImage >Change the region of a label map
itk::CheckerBoardImageFilter< TImage >Combines two images in a checkerboard pattern
itk::ChildTreeIterator< TTreeType >
itk::Statistics::ChiSquareDistributionChiSquareDistribution class defines the interface for a univariate Chi-Square distribution (pdfs, cdfs, etc.)
itk::Functor::Clamp< TInput, TOutput >
itk::ClampImageFilter< TInputImage, TOutputImage >Casts input pixels to output pixel type and clamps the output pixel values to the range supported by the output pixel type
itk::ClassifierBase< TDataContainer >Base class for classifier objects
classname
itk::CleanQuadEdgeMeshFilter< TInput, TOutput >TODO
itk::ClosingByReconstructionImageFilter< TInputImage, TOutputImage, TKernel >Closing by reconstruction of an image
itk::MultivariateLegendrePolynomial::CoefficientVectorSizeMismatchException object
itk::CollidingFrontsImageFilter< TInputImage, TOutputImage >Selects a region of space where two independent fronts run towards each other
itk::Function::ColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::ColorTable< TPixel >Define a color table for image visualisation
itk::CommandSuperclass for callback/observer methods
itk::CommandIterationUpdate< TOptimizer >
itk::CommandVnlIterationUpdate< TOptimizer >
itk::Concept::Comparable< T1, T2 >
itk::AttributeKeepNObjectsLabelMapFilter< TImage, TAttributeAccessor >::Comparator
itk::AttributeRelabelLabelMapFilter< TImage, TAttributeAccessor >::Comparator
itk::CompareHistogramImageToImageMetric< TFixedImage, TMovingImage >Compares Histograms between two images to be registered to a Training Histogram
itk::AttributeMorphologyBaseImageFilter< TInputImage, TOutputImage, TAttribute, TFunction >::ComparePixStruct
itk::Testing::ComparisonImageFilter< TInputImage, TOutputImage >Implements comparison between two images
itk::CompensatedSummation< TFloat >Perform more precise accumulation of floating point numbers
itk::Statistics::CompletelyConnectedWeightSet< TMeasurementVector, TTargetVector >This is the itkCompletelyConnectedWeightSet class
itk::ComplexBSplineInterpolateImageFunction< TImageType, TCoordRep, TCoefficientType >Complex wrapper around BSplineInterpolateImageFunction
itk::ComplexConjugateImageAdaptor< TImage >Presents each pixel of a complex image as its complex conjugate
itk::Accessor::ComplexConjugatePixelAccessor< TComplexType >Provide access to the conjugate of a std::complex<> value
itk::Functor::ComplexToImaginary< TInput, TOutput >
itk::ComplexToImaginaryImageAdaptor< TImage, TOutputPixelType >Presents a complex image as being composed of imag() part of its pixels
itk::ComplexToImaginaryImageFilter< TInputImage, TOutputImage >Computes pixel-wise the imaginary part of a complex image
itk::Accessor::ComplexToImaginaryPixelAccessor< TInternalType, TExternalType >Give access to the Imaginary part of a std::complex<> value
itk::Functor::ComplexToModulus< TInput, TOutput >
itk::ComplexToModulusImageAdaptor< TImage, TOutputPixelType >Presents a complex image as being composed of vcl_abs() part of its pixels
itk::ComplexToModulusImageFilter< TInputImage, TOutputImage >Computes pixel-wise the Modulus of a complex image
itk::Accessor::ComplexToModulusPixelAccessor< TInternalType, TExternalType >Give access to the Modulus of a std::complex<> value
itk::Functor::ComplexToPhase< TInput, TOutput >
itk::ComplexToPhaseImageAdaptor< TImage, TOutputPixelType >Presents a complex image as being composed of arg() part of its pixels
itk::ComplexToPhaseImageFilter< TInputImage, TOutputImage >Computes pixel-wise the modulus of a complex image
itk::Accessor::ComplexToPhasePixelAccessor< TInternalType, TExternalType >Give access to the Phase part of a std::complex<> value
itk::Functor::ComplexToReal< TInput, TOutput >
itk::ComplexToRealImageAdaptor< TImage, TOutputPixelType >Presents a complex image as being composed of real() part of its pixels
itk::ComplexToRealImageFilter< TInputImage, TOutputImage >Computes pixel-wise the real(x) part of a complex image
itk::Accessor::ComplexToRealPixelAccessor< TInternalType, TExternalType >Give access to the Real part of a std::complex<> value
itk::Functor::Compose2DCovariantVector< TInput >
itk::Compose2DCovariantVectorImageFilter< TInputImage, TOutputImage >Implements pixel-wise composition of an 2D covariant vector pixel from two scalar images
itk::Functor::Compose2DVector< TInput >
itk::Compose2DVectorImageFilter< TInputImage, TOutputImage >Implements pixel-wise composition of an 2D vector pixel from two scalar images
itk::Functor::Compose3DCovariantVector< TInput >
itk::Compose3DCovariantVectorImageFilter< TInputImage, TOutputImage >Implements pixel-wise composition of an 3D covariant vector pixel from three scalar images
itk::Functor::Compose3DVector< TInput >
itk::Compose3DVectorImageFilter< TInputImage, TOutputImage >Implements pixel-wise composition of an 3D vector pixel from three scalar images
itk::ComposeDisplacementFieldsImageFilter< TInputImage, TOutputImage >Compose two displacement fields
itk::ComposeImageFilter< TInputImage, TOutputImage >ComposeImageFilter combine several scalar images into a multicomponent image
itk::Functor::ComposeRGB< TInput >
itk::ComposeRGBImageFilter< TInputImage, TOutputImage >Implements pixel-wise composition of an RGB pixel from three scalar images
itk::CompositeTransform< TScalar, NDimensions >This class contains a list of transforms and concatenates them by composition
itk::CompositeTransformIOHelperAn adapter that adapts CompositeTransform into the TransformReader/Writer
itk::ConditionalConstIterator< TImage >A base class for other iterators where membership in the set of output pixels is conditional upon some property, calculation, etc. For example, a threshold iterator might walk a region and return only those pixels which meet a minimum intensity condition
itk::ConditionVariableA thread synchronization object used to suspend execution until some condition on shared data is met
itk::ConditionVariableType
itk::ConfidenceConnectedImageFilter< TInputImage, TOutputImage >Segment pixels with similar statistics using connectivity
itk::ConformalFlatteningMeshFilter< TInputMesh, TOutputMesh >ConformalFlatteningMeshFilter applies a conformal mapping from 3D to 2D
itk::ConformalMatrixCoefficients< TInputMesh >Compute a matrix filed by Conformal Coefficients of the edge wherever two vertices are connected by an edge
itk::ConicShellInteriorExteriorSpatialFunction< VDimension, TInput >Spatial function implementation of a conic shell
itk::ConjugateGradientOptimizerWrap of the vnl_conjugate_gradient
itk::ConnectedComponentFunctorImageFilter< TInputImage, TOutputImage, TFunctor, TMaskImage >A generic connected components filter that labels the objects in an artibitrary image
itk::ConnectedComponentImageFilter< TInputImage, TOutputImage, TMaskImage >Label the objects in a binary image
itk::ConnectedRegionsMeshFilter< TInputMesh, TOutputMesh >Extract portions of a mesh that are connected at vertices
itk::ConnectedThresholdImageFilter< TInputImage, TOutputImage >Label pixels that are connected to a seed and lie within a range of values
itk::watershed::Segmenter< TInputImage >::connectivity_t
itk::ConstantBoundaryCondition< TInputImage, TOutputImage >This boundary condition returns a constant value for out-of-bounds image pixels
itk::ConstantPadImageFilter< TInputImage, TOutputImage >Increase the image size by padding with a constant value
itk::LabelObject< TLabel, VImageDimension >::ConstIndexIterator
itk::LevelSetContainerBase< TIdentifier, TLevelSet >::ConstIterator
itk::LevelSetEquationContainerBase< TTermContainer >::ConstIterator
itk::LevelSetEquationTermContainerBase< TInputImage, TLevelSetContainer >::ConstIterator
itk::VectorContainer< TElementIdentifier, TElement >::ConstIterator
itk::Statistics::Histogram< TMeasurement, TFrequencyContainer >::ConstIteratorClass that walks through the elements of the histogram
itk::LabelMap< TLabelObject >::ConstIteratorA forward iterator over the LabelObjects of a LabelMap
itk::Statistics::ImageToListSampleAdaptor< TImage >::ConstIteratorConst Iterator
itk::Statistics::JointDomainImageToListSampleAdaptor< TImage >::ConstIteratorConst Iterator
itk::Statistics::ListSample< TMeasurementVector >::ConstIteratorConst Iterator
itk::Statistics::MembershipSample< TSample >::ConstIterator
itk::Statistics::PointSetToListSampleAdaptor< TPointSet >::ConstIterator
itk::IndexedContainerInterface< TElementIdentifier, TElement >::ConstIteratorSupport const iteration operations through a container. Dereferencing the iterator must provide an object with the following methods: ElementIdentifier Index(void) const; const Element& Value(void) const;
itk::Statistics::Subsample< TSample >::ConstIterator
itk::Statistics::VectorContainerToListSampleAdaptor< TVectorContainer >::ConstIterator
itk::MapContainer< TElementIdentifier, TElement >::ConstIteratorThe const iterator type for the map
itk::ConstShapedNeighborhoodIterator< TImage, TBoundaryCondition >::ConstIterator
itk::LabelObject< TLabel, VImageDimension >::ConstLineIteratorA forward iterator over the lines of a LabelObject
itk::ConstNeighborhoodIterator< TImage, TBoundaryCondition >Const version of NeighborhoodIterator, defining iteration of a local N-dimensional neighborhood of pixels across an itk::Image
itk::ConstrainedRegionBasedLevelSetFunctionSharedData< TInputImage, TFeatureImage, TSingleData >Helper class used to share data in the ScalarChanAndVeseLevelSetFunction
itk::Functor::ConstrainedValueAddition< TInput1, TInput2, TOutput >
itk::ConstrainedValueAdditionImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements pixel-wise the computation of constrained value addition
itk::Functor::ConstrainedValueDifference< TInput1, TInput2, TOutput >
itk::ConstrainedValueDifferenceImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements pixel-wise the computation of constrained value difference
itk::Concept::DefaultConstructible< T >::Constraints
itk::Concept::CopyConstructible< T >::Constraints
itk::Concept::Convertible< T1, T2 >::Constraints
itk::Concept::Assignable< T >::Constraints
itk::Concept::LessThanComparable< T1, T2 >::Constraints
itk::Concept::GreaterThanComparable< T1, T2 >::Constraints
itk::Concept::EqualityComparable< T1, T2 >::Constraints
itk::Concept::Comparable< T1, T2 >::Constraints
itk::Concept::AdditiveOperators< T1, T2, T3 >::Constraints
itk::Concept::AdditiveAndAssignOperators< T1, T2 >::Constraints
itk::Concept::MultiplyOperator< T1, T2, T3 >::Constraints
itk::Concept::MultiplyAndAssignOperator< T1, T2 >::Constraints
itk::Concept::DivisionAndAssignOperators< T1, T2 >::Constraints
itk::Concept::DivisionOperators< T1, T2, T3 >::Constraints
itk::Concept::LogicalOperators< T1, T2, T3 >::Constraints
itk::Concept::BracketOperator< T1, T2, T3 >::Constraints
itk::Concept::NotOperator< T >::Constraints
itk::Concept::IncrementDecrementOperators< T >::Constraints
itk::Concept::OStreamWritable< T >::Constraints
itk::Concept::Signed< T >::Constraints
itk::Concept::SameType< T1, T2 >::Constraints
itk::Concept::SameDimension< D1, D2 >::Constraints
itk::Concept::HasNumericTraits< T >::Constraints
itk::Concept::HasPixelTraits< T >::Constraints
itk::Concept::HasValueType< T >::Constraints
itk::Concept::HasZero< T >::Constraints
itk::Concept::HasJoinTraits< T1, T2 >::Constraints
itk::Concept::SameDimensionOrMinusOne< D1, D2 >::Constraints
itk::Concept::SameDimensionOrMinusOneOrTwo< D1, D2 >::Constraints
itk::Concept::IsInteger< T >::Constraints
itk::Concept::IsNonInteger< T >::Constraints
itk::Concept::IsFloatingPoint< T >::Constraints
itk::Concept::IsFixedPoint< T >::Constraints
itk::FixedArray< TValueType, VLength >::ConstReverseIteratorA const reverse iterator through an array
itk::ConstShapedNeighborhoodIterator< TImage, TBoundaryCondition >Const version of ShapedNeighborhoodIterator, defining iteration of a local N-dimensional neighborhood of pixels across an itk::Image
itk::ConstSliceIterator< TPixel, TContainer >A flexible iterator for ITK containers(i.e. itk::Neighborhood) that support pixel access through operator[]
itk::ConstSparseFieldLayerIterator< TNodeType >Used to iterate through an itkSparseFieldLayer
itk::ContinuousIndex< TCoordRep, VIndexDimension >A templated class holding a point in n-Dimensional image space
itk::ContourDirectedMeanDistanceImageFilter< TInputImage1, TInputImage2 >Computes the directed Mean distance between the boundaries of non-zero pixel regions of two images
itk::ContourExtractor2DImageFilter< TInputImage >Computes a list of PolyLineParametricPath objects from the contours in a 2D image
itk::ContourMeanDistanceImageFilter< TInputImage1, TInputImage2 >Computes the Mean distance between the boundaries of non-zero regions of two images
itk::ContourSpatialObject< TDimension >Representation of a Contour based on the spatial object classes
itk::ContourSpatialObjectPoint< TPointDimension >Point used for a Contour definition
itk::ContourExtractor2DImageFilter< TInputImage >::ContourType
itk::bio::Gene::ControlDomainType
itk::Function::ConvergenceMonitoringFunction< TScalar, TEnergyValue >Abstract base class which monitors convergence during the course of optimization
itk::Concept::Convertible< T1, T2 >
itk::ConvertLabelMapFilter< TInputImage, TOutputImage >Converts the LabelObjects of a LabelMap to a differente type of LabelObejct
itk::ConvertPixelBuffer< InputPixelType, OutputPixelType, OutputConvertTraits >Class to convert blocks of data from one type to another
itk::ConvertPixelBuffer< InputPixelType, Array< T >, OutputConvertTraits >
itk::ConvertPixelBuffer< InputPixelType, VariableLengthVector< T >, OutputConvertTraits >
itk::ConvolutionImageFilter< TInputImage, TKernelImage, TOutputImage >Convolve a given image with an arbitrary image kernel
itk::ConvolutionImageFilterBase< TInputImage, TKernelImage, TOutputImage >Abstract base class for the convolution image filters
itk::Function::CoolColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::Functor::JoinFunctor< TPixel1, TPixel2 >::CopierDispatch< VDimension >
itk::Functor::JoinFunctor< TPixel1, TPixel2 >::CopierDispatchBase
itk::Function::CopperColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::Concept::CopyConstructible< T >
itk::CorrelationCoefficientHistogramImageToImageMetric< TFixedImage, TMovingImage >Computes correlation coefficient similarity measure between two images to be registered
itk::CorrelationImageToImageMetricv4< TFixedImage, TMovingImage, TVirtualImage >Class implementing normalized cross correlation image metric
itk::CorrelationImageToImageMetricv4GetValueAndDerivativeThreader< TDomainPartitioner, TImageToImageMetric, TCorrelationMetric >Processes points for CorrelationImageToImageMetricv4 GetValueAndDerivative
itk::CorrelationImageToImageMetricv4HelperThreader< TDomainPartitioner, TImageToImageMetric, TCorrelationMetric >
itk::CorrespondenceDataStructureIterator< TStructureType >An iterator designed to easily traverse an CorrespondenceDataStructure
itk::Functor::Cos< TInput, TOutput >
itk::CosImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_cos() of its pixels
itk::CosImageFilter< TInputImage, TOutputImage >Computes the cosine of each pixel
itk::Function::CosineWindowFunction< VRadius, TInput, TOutput >Window function for sinc interpolation.

\[ w(x) = cos(\frac{\pi x}{2 m} ) \]

itk::Accessor::CosPixelAccessor< TInternalType, TExternalType >Give access to the vcl_cos() function of a value
itk::CostFunctionBase class for cost functions intended to be used with Optimizers
itk::CovarianceImageFunction< TInputImage, TCoordRep >Calculate the covariance matrix in the neighborhood of a pixel in a Vector image
itk::Statistics::CovarianceSampleFilter< TSample >Calculates the covariance matrix of the target sample data
itk::CovariantVector< T, NVectorDimension >A templated class holding a n-Dimensional covariant vector
itk::CoxDeBoorBSplineKernelFunction< VSplineOrder, TRealValueType >BSpline kernel used for density estimation and nonparameteric regression
itk::CreateObjectFunction< T >Used to create callback functions that create ITK Objects for use with the itk::ObjectFactory
itk::CreateObjectFunctionBaseDefine API for object creation callback functions
itk::CropImageFilter< TInputImage, TOutputImage >Decrease the image size by cropping the image by an itk::Size at both the upper and lower bounds of the largest possible region
itk::CropLabelMapFilter< TInputImage >Crop a LabelMap image
CrossCompute the cross product of two vectors of dimension 3, independently of the type of the values of vector's elements
itk::CrossHelper< TVector >
itk::CStyleCommandA Command subclass that calls a pointer to a C function
itk::CSVArray2DDataObject< TData >Stores parsed data from csv files
itk::CSVArray2DFileReader< TData >Parses csv files and stores the data in a itkCSVArray2DDataObject
itk::CSVFileReaderBaseA base class that contains common methods used for parsing csv files
itk::CSVNumericObjectFileWriter< TValueType, NRows, NColumns >Writes out numeric itk data objects to a csv file
itk::CumulativeGaussianCostFunctionCost function for the Cumulative Gaussian Optimizer
itk::CumulativeGaussianOptimizerThis is an optimizer specific to estimating the parameters of Cumulative Gaussian sampled data
itk::CurvatureAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >
itk::CurvatureFlowFunction< TImage >This class encapsulate the finite difference equation which drives a curvature flow denoising algorithm
itk::CurvatureFlowImageFilter< TInputImage, TOutputImage >Denoise an image using curvature driven flow
itk::CurvatureNDAnisotropicDiffusionFunction< TImage >
itk::CurvatureRegistrationFilter< TFixedImage, TMovingImage, TDisplacementField, TImageForceFunction >Deformably register two images using the fast curvature algorithm
itk::CurvesLevelSetFunction< TImageType, TFeatureImageType >This function is used in CurvesLevelSetImageFilter to segment structures in images based on user supplied edge potential map
itk::CurvesLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on user supplied edge potential map
itk::Function::CustomColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::CyclicShiftImageFilter< TInputImage, TOutputImage >Perform a cyclic spatial shift of image intensities on the image grid
itk::CylinderSpatialObjectThis class describe a cylinder in 3D only
itk::DanielssonDistanceMapImageFilter< TInputImage, TOutputImage, TVoronoiImage >This filter computes the distance map of the input image as an approximation with pixel accuracy to the Euclidean distance
itk::DataObjectBase class for all data objects in ITK
itk::DataObjectConstIteratorA forward iterator over the DataObject of a ProcessObject
itk::DataObjectDecorator< T >Decorates any subclass of itkObject with a DataObject API
itk::DataObjectErrorException object for DataObject exceptions
itk::DataObjectIteratorA forward iterator over the DataObject of a ProcessObject
itk::LevelSetBase< TInput, VDimension, TOutput, TDomain >::DataType< T >Internal class used for one computed characteritic
itk::DecimateFramesVideoFilter< TVideoStream >Reduce a video's frame-rate by keeping every Nth frame
itk::DecimationQuadEdgeMeshFilter< TInput, TOutput, TCriterion >
itk::Statistics::DecisionRuleBase class for decision rules that return a class label based on a set of discriminant scores
itk::Concept::DefaultConstructible< T >
itk::DefaultConvertPixelTraits< PixelType >Traits class used to by ConvertPixels to convert blocks of pixels
itk::DefaultConvertPixelTraits< ::std::complex< TComponent > >
itk::DefaultConvertPixelTraits< Matrix< VComponent, VRows, VCols > >
itk::DefaultConvertPixelTraits< Offset< VDimension > >
itk::DefaultConvertPixelTraits< VariableLengthVector< VComponent > >
itk::DefaultDynamicMeshTraits< TPixelType, VPointDimension, VMaxTopologicalDimension, TCoordRep, TInterpolationWeight, TCellPixelType >A simple structure that holds type information for a mesh and its cells
itk::DefaultImageTraits< TPixelType, VImageDimension, TPixelContainer >Default ImageTraits for any PixelType
itk::DefaultPixelAccessor< TType >Give access to partial aspects a type
itk::DefaultPixelAccessorFunctor< TImageType >Provides a common API for pixel accessors for Image and VectorImage
itk::DefaultStaticMeshTraits< TPixelType, VPointDimension, VMaxTopologicalDimension, TCoordRep, TInterpolationWeight, TCellPixelType >
itk::DefaultVectorPixelAccessor< TType >Give access to partial aspects of a type
itk::DefaultVectorPixelAccessorFunctor< TImageType >This class provides a common API for pixel accessors for Image and VectorImage. (between the DefaultVectorPixelAccessor and DefaultPixelAccessor)
DeformableMesh3DThe DeformableMesh3DFilter is used to deform a mesh (deformable model) under a potential force in 2D or 3D. The potential force is derived from the gradient information in the medical image and it will make the model deform to fit to the boundary features
itk::DeformableMesh3DFilter< TInputMesh, TOutputMesh >
itk::DeformableSimplexMesh3DBalloonForceFilter< TInputMesh, TOutputMesh >Additional to its superclass this model adds an balloon force component to the internal forces
itk::DeformableSimplexMesh3DFilter< TInputMesh, TOutputMesh >Three-dimensional deformable model for image segmentation
itk::DeformableSimplexMesh3DGradientConstraintForceFilter< TInputMesh, TOutputMesh >Additional to its superclass this class reimplemets the external forces methos in which the scan line algorithm is used to find highest gradient is found in the direction of the normal to each vertex within a specified range
itk::DelaunayConformingQuadEdgeMeshFilter< TInputMesh, TOutputMesh >FIXME Add documentation
itk::DeleteEvent
itk::DemonsRegistrationFilter< TFixedImage, TMovingImage, TDisplacementField >Deformably register two images using the demons algorithm
itk::DemonsRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >
itk::DenseFiniteDifferenceImageFilter< TInputImage, TOutputImage >::DenseFDThreadStruct
itk::DenseFiniteDifferenceImageFilter< TInputImage, TOutputImage >
itk::Statistics::DenseFrequencyContainer2This class is a container for frequencies of bins in an histogram
itk::DerivativeImageFilter< TInputImage, TOutputImage >Computes the directional derivative of an image. The directional derivative at each pixel location is computed by convolution with a derivative operator of user-specified order
itk::DerivativeOperator< TPixel, VDimension, TAllocator >A NeighborhoodOperator for taking an n-th order derivative at a pixel
itk::DicomImageIORead DicomImage file format
itk::DICOMImageIO2Read DICOMImage file format
itk::DICOMImageIO2FactoryCreate instances of DICOMImageIO2 objects using an object factory
itk::DicomImageIOFactoryCreate instances of DicomImageIO objects using an object factory
itk::DICOMSeriesFileNamesGenerate an ordered sequence of filenames
itk::DiffeomorphicDemonsRegistrationFilter< TFixedImage, TMovingImage, TDisplacementField >Deformably register two images using a diffeomorphic demons algorithm
itk::DifferenceOfGaussiansGradientImageFilter< TInputImage, TDataType >Performs difference-of-gaussians gradient detection
itk::DiffusionTensor3D< TComponent >Represent a diffusion tensor as used in DTI images
itk::DiffusionTensor3DReconstructionImageFilter< TReferenceImagePixelType, TGradientImagePixelType, TTensorPixelType, TMaskImageType >This class takes as input one or more reference image (acquired in the absence of diffusion sensitizing gradients) and 'n' diffusion weighted images and their gradient directions and computes an image of tensors. (with DiffusionTensor3D as the pixel type). Once that is done, you can apply filters on this tensor image to compute FA, ADC, RGB weighted maps etc
itk::DilateObjectMorphologyImageFilter< TInputImage, TOutputImage, TKernel >Dilation of an object in an image
itk::DirectedHausdorffDistanceImageFilter< TInputImage1, TInputImage2 >Computes the directed Hausdorff distance between the set of non-zero pixels of two images
itk::DirectFourierReconstructionImageToImageFilter< TInputImage, TOutputImage >Direct fourier reconstruction filter of a tomographic volume
itk::MovingHistogramImageFilterBase< TInputImage, TOutputImage, TKernel >::DirectionCost
itk::DirectoryPortable directory/filename traversal
itk::DiscreteCurvatureQuadEdgeMeshFilter< TInputMesh, TOutputMesh >FIXME
itk::DiscreteCurvatureTensorQuadEdgeMeshFilter< TInputMesh, TOutputMesh >FIXME Add documentation here
itk::DiscreteGaussianCurvatureQuadEdgeMeshFilter< TInputMesh, TOutputMesh >See the following paper title: Discrete Differential-Geometry Operators for Triangulated 2-Manifolds authors: Mark Meyer, Mathieu Desbrun, Peter Schroder, Alan H. Barr conference: VisMath '02 location: Berlin (Germany)
itk::DiscreteGaussianDerivativeImageFilter< TInputImage, TOutputImage >Calculates image derivatives using discrete derivative gaussian kernels. This filter calculates Gaussian derivative by separable convolution of an image and a discrete Gaussian derivative operator (kernel)
itk::DiscreteGaussianDerivativeImageFunction< TInputImage, TOutput >Compute the discrete gaussian derivatives of an the image at a specific location in space, i.e. point, index or continuous index. This class computes a single derivative given the order in each direction (by default zero). This class is templated over the input image type
itk::DiscreteGaussianImageFilter< TInputImage, TOutputImage >Blurs an image by separable convolution with discrete gaussian kernels. This filter performs Gaussian blurring by separable convolution of an image and a discrete Gaussian operator (kernel)
itk::DiscreteGradientMagnitudeGaussianImageFunction< TInputImage, TOutput >Compute the discrete gradient magnitude gaussian of an the image at a specific location in space, i.e. point, index or continuous index. This class computes a single derivative given the order in each direction (by default zero). This class is templated over the input image type
itk::DiscreteHessianGaussianImageFunction< TInputImage, TOutput >Compute the Hessian Gaussian of an image at a specific location in space by calculating discrete second-order gaussian derivatives. This class is templated over the input image type
itk::DiscreteLevelSetImageBase< TOutput, VDimension >Abstract class for a level-set function on one Image
itk::DiscreteMaximumCurvatureQuadEdgeMeshFilter< TInputMesh, TOutputMesh >FIXME Add documentation here
itk::DiscreteMeanCurvatureQuadEdgeMeshFilter< TInputMesh, TOutputMesh >See the following paper title: Discrete Differential-Geometry Operators for Triangulated 2-Manifolds authors: Mark Meyer, Mathieu Desbrun, Peter Schroder, Alan H. Barr conference: VisMath '02 location: Berlin (Germany)
itk::DiscreteMinimumCurvatureQuadEdgeMeshFilter< TInputMesh, TOutputMesh >FIXME add documentation here
itk::DiscretePrincipalCurvaturesQuadEdgeMeshFilter< TInputMesh, TOutputMesh >FIXME add documentation here
itk::MinMaxCurvatureFlowFunction< TImage >::Dispatch< VDimension >
itk::LinearInterpolateImageFunction< TInputImage, TCoordRep >::Dispatch< int >
itk::BSplineDerivativeKernelFunction< VSplineOrder, TRealValueType >::Dispatch< int >
itk::BSplineKernelFunction< VSplineOrder, TRealValueType >::Dispatch< int >
itk::MinMaxCurvatureFlowFunction< TImage >::DispatchBase
itk::ImageToImageFilterDetail::DispatchBaseBase class for a class used to dispatch to dimension specific implementations
itk::LinearInterpolateImageFunction< TInputImage, TCoordRep >::DispatchBase
itk::BSplineDerivativeKernelFunction< VSplineOrder, TRealValueType >::DispatchBase
itk::BSplineKernelFunction< VSplineOrder, TRealValueType >::DispatchBase
itk::DisplacementFieldJacobianDeterminantFilter< TInputImage, TRealType, TOutputImage >Computes a scalar image from a vector image (e.g., deformation field) input, where each output scalar at each pixel is the Jacobian determinant of the vector field at that location. This calculation is correct in the case where the vector image is a "displacement" from the current location. The computation for the jacobian determinant is: det[ dT/dx ] = det[ I + du/dx ]
itk::DisplacementFieldTransform< TScalar, NDimensions >Provides local/dense/high-dimensionaltiy transformation via a a displacement field
itk::DisplacementFieldTransformParametersAdaptor< TTransform >DisplacementFieldTransformParametersAdaptor is a helper class intended to definition
itk::Statistics::DistanceMetric< TVector >This class declares common interfaces for distance functions
itk::Statistics::DistanceToCentroidMembershipFunction< TVector >DistanceToCentroidMembershipFunction models class membership using a distance metric
itk::Functor::Div< TInput1, TInput2, TOutput >
itk::DivideByConstantImageFilter< TInputImage, TConstant, TOutputImage >Add a constant to all input pixels
itk::DivideImageFilter< TInputImage1, TInputImage2, TOutputImage >Pixel-wise division of two images
itk::Functor::DivideOrZeroOut< TNumerator, TDenominator, TOutput >
itk::DivideOrZeroOutImageFilter< TInputImage1, TInputImage2, TOutputImage >
itk::Concept::DivisionAndAssignOperators< T1, T2 >
itk::Concept::DivisionOperators< T1, T2, T3 >
itk::DomainThreader< TDomainPartitioner, TAssociate >Multi-threaded processing on a domain by processing sub-domains per thread
itk::DoubleThresholdImageFilter< TInputImage, TOutputImage >Binarize an input image using double thresholding
itk::DTITubeSpatialObject< TDimension >Representation of a tube based on the spatial object classes
itk::DTITubeSpatialObjectPoint< TPointDimension >Point used for a tube definition
itk::DynamicLoaderPortable loading of dynamic libraries or dll's
itk::watershed::SegmentTable< TScalarType >::edge_pair_t
itk::EdgeDecimationQuadEdgeMeshFilter< TInput, TOutput, TCriterion >
itk::Functor::EdgePotential< TInput, TOutput >
itk::EdgePotentialImageFilter< TInputImage, TOutputImage >Computes the edge potential of an image from the image gradient
itk::EigenAnalysis2DImageFilter< TInputImage, TEigenValueImage, TEigenVectorImage >Computes pixel-wise the eigen values and eigen vectors of a 2D symmetrical matrix
itk::ElasticBodyReciprocalSplineKernelTransform< TScalarType, NDimensions >
itk::ElasticBodySplineKernelTransform< TScalarType, NDimensions >This class defines the elastic body spline (EBS) transformation
itk::fem::ElementAbstract base element class
itk::fem::Element1DStress< TBaseClass >Class that is used to define linear elasticity problem in 1D space
itk::fem::Element2DC0LinearLine2-noded, linear, C0 continuous line element in 2D space. takes loads only along the length of the axis
itk::fem::Element2DC0LinearLineStress2-noded finite element class in 2D space for linear elasticity problem
itk::fem::Element2DC0LinearQuadrilateral4-noded, linear, C0 continuous finite element in 2D space.The ordering of the nodes is counter clockwise. That is the nodes should be defined in the following order:
itk::fem::Element2DC0LinearQuadrilateralMembrane4-noded finite element class in 2D space
itk::fem::Element2DC0LinearQuadrilateralStrain4-noded finite element class in 2D space for linear elasticity problemThe ordering of the nodes is counter clockwise. That is the nodes should be defined in the following order:
itk::fem::Element2DC0LinearQuadrilateralStress4-noded finite element class in 2D space
itk::fem::Element2DC0LinearTriangular3-noded, linear, C0 continuous finite element in 2D space.The ordering of the nodes is counter clockwise. That is the nodes should be defined in the following order:
itk::fem::Element2DC0LinearTriangularMembrane3-noded finite element class in 2D space
itk::fem::Element2DC0LinearTriangularStrain3-noded finite element class in 2D space for linear elasticity problem
itk::fem::Element2DC0LinearTriangularStress3-noded finite element class in 2D space for linear elasticity problem
itk::fem::Element2DC0QuadraticTriangular6-noded, quadratic, C0 continuous finite element in 2D space that defines a triangle
itk::fem::Element2DC0QuadraticTriangularStrain6-noded finite element class in 2D space for linear elasticity problem that defines a triangle element
itk::fem::Element2DC0QuadraticTriangularStress6-noded finite element class in 2D space for linear elasticity problem. The constitutive equation used is for plane stress
itk::fem::Element2DC1Beam1D Beam (spring that also bends) finite element in 2D space
itk::fem::Element2DMembrane< TBaseClass >Class that is used to define a membrane energy problem in 2D space
itk::fem::Element2DStrain< TBaseClass >Class that is used to define linear elasticity problem in 2D space
itk::fem::Element2DStress< TBaseClass >Class that is used to define linear elasticity problem in 2D space
itk::fem::Element3DC0LinearHexahedron8-noded, linear, C0 continuous finite element in 3D space
itk::fem::Element3DC0LinearHexahedronMembrane8-noded finite element class in 3D space. The constitutive equation used is from membrane bending energy
itk::fem::Element3DC0LinearHexahedronStrain8-noded finite element class in 3D space. The constitutive equation used is from linear elasticity theory
itk::fem::Element3DC0LinearTetrahedron4-noded, linear, C0 continuous finite element in 3D space
itk::fem::Element3DC0LinearTetrahedronMembrane4-noded finite element class in 3D space. The constitutive equation used is from membrane bending energy
itk::fem::Element3DC0LinearTetrahedronStrain4-noded finite element class in 3D space for linear elasticity problem
itk::fem::Element3DC0LinearTriangular3-noded, linear, C0 continuous finite element in 2D space
itk::fem::Element3DC0LinearTriangularLaplaceBeltrami3-noded finite element class in 3D space for surface LaplaceBeltrami problem
itk::fem::Element3DC0LinearTriangularMembrane3-noded finite element class in 3D space for surface membrane problem
itk::fem::Element3DMembrane< TBaseClass >Class that is used to define a membrane energy problem in 3D space
itk::fem::Element3DMembrane1DOF< TBaseClass >Class that is used to define a membrane energy problem in 3D space
itk::fem::Element3DStrain< TBaseClass >Class that is used to define linear elasticity problem in 3D space
itk::fem::ElementStd< VNumberOfNodes, VNumberOfSpatialDimensions, TBaseClass >Implements standard node management in the element classes
itk::ElementWrapperInterface< TElement, TElementIdentifier >
itk::ElementWrapperPointerInterface< TElementWrapperPointer, TElementIdentifier >
itk::EllipseSpatialObject< TDimension >TODO
itk::EllipsoidInteriorExteriorSpatialFunction< VDimension, TInput >Function implementation of an ellipsoid
itk::Functor::ElongationLabelObjectAccessor< TLabelObject >
itk::EndEvent
itk::EndPickEvent
itk::Concept::EqualityComparable< T1, T2 >
itk::watershed::EquivalenceRelabeler< TScalarType, TImageDimension >
itk::EquivalencyTableHash table to manage integral label equivalencies
itk::Functor::EquivalentEllipsoidDiameterLabelObjectAccessor< TLabelObject >
itk::Functor::EquivalentSphericalPerimeterLabelObjectAccessor< TLabelObject >
itk::Functor::EquivalentSphericalRadiusLabelObjectAccessor< TLabelObject >
itk::ErodeObjectMorphologyImageFilter< TInputImage, TOutputImage, TKernel >Erosion of an object in an image
itk::Statistics::ErrorBackPropagationLearningFunctionBase< LayerType, TTargetVector >The ErrorBackPropagationLearningFunctionBase is the base class for all the ErrorBackPropagationLearning strategies
itk::Statistics::ErrorBackPropagationLearningWithMomentum< LayerType, TTargetVector >The ErrorBackPropagationLearningWithMomentum is the base class for all the ErrorBackPropagationLearning strategies
itk::Statistics::ErrorFunctionBase< TMeasurementVector, TTargetVector >This is the itkErrorFunctionBase class
itk::ESMDemonsRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >Fast implementation of the symmetric demons registration force
itk::Statistics::EuclideanDistanceMetric< TVector >Euclidean distance function
itk::EuclideanDistancePointMetric< TFixedPointSet, TMovingPointSet, TDistanceMap >Computes the minimum distance between a moving point-set and a fixed point-set. A vector of minimum closest point distance is created for each point in the moving point-set. No correspondance is needed. For speed consideration, the point-set with the minimum number of points should be used as the moving point-set. If the number of points is high, the possibility of setting a distance map should improve the speed of the closest point computation
itk::EuclideanDistancePointSetToPointSetMetricv4< TFixedPointSet, TMovingPointSet >Computes the Euclidan distance metric between two point sets
itk::Statistics::EuclideanSquareDistanceMetric< TVector >Computes Euclidean distance between origin and given measurement vector
itk::Euler2DTransform< TScalarType >Euler2DTransform of a vector space (e.g. space coordinates)
itk::Euler3DTransform< TScalarType >Euler3DTransform of a vector space (e.g. space coordinates)
itk::EventObjectAbstraction of the Events used to communicating among filters and with GUIs
itk::ExceptionObjectStandard exception handling object
itk::ExhaustiveOptimizerOptimizer that fully samples a grid on the parametric space
itk::ExitEvent
itk::Functor::Exp< TInput, TOutput >
itk::ExpandImageFilter< TInputImage, TOutputImage >Expand the size of an image by an integer factor in each dimension
itk::ExpectationBasedPointSetToPointSetMetricv4< TFixedPointSet, TMovingPointSet >Computes an expectation-based metric between two point sets
itk::Statistics::ExpectationMaximizationMixtureModelEstimator< TSample >This class generates the parameter estimates for a mixture model using expectation maximization strategy
itk::ExpImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_exp() of its pixels
itk::ExpImageFilter< TInputImage, TOutputImage >Computes the exponential function of each pixel
itk::Functor::ExpNegative< TInput, TOutput >
itk::ExpNegativeImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_exp() of its pixels
itk::ExpNegativeImageFilter< TInputImage, TOutputImage >Computes the function exp(-K.x) for each input pixel
itk::Accessor::ExpNegativePixelAccessor< TInternalType, TExternalType >Give access to the vcl_exp() function of a value
itk::ExponentialDisplacementFieldImageFilter< TInputImage, TOutputImage >Computes a diffeomorphic displacement field as the Lie group exponential of a vector field
itk::Accessor::ExpPixelAccessor< TInternalType, TExternalType >Give access to the vcl_exp() function of a value
itk::ExtensionVelocitiesImageFilter< TLevelSet, TAuxValue, VAuxDimension >Extend velocities smoothly from a particular level set
itk::ExtractImageFilter< TInputImage, TOutputImage >Decrease the image size by cropping the image to the selected region bounds
itk::ImageToImageFilterDetail::ExtractImageFilterRegionCopier< T1, T2 >A special variation of ImageRegionCopier for when the output image has fewer dimensions than the input image
itk::ExtractOrthogonalSwath2DImageFilter< TImage >Extracts into rectangular form a "swath" image from the input image along the parametric path
itk::Testing::ExtractSliceImageFilter< TInputImage, TOutputImage >Decrease the image size by cropping the image to the selected region bounds
itk::ExtrapolateImageFunction< TInputImage, TCoordRep >Base class for all image extrapolaters
itk::watershed::Boundary< TScalarType, TDimension >::face_pixel_t
itk::FastApproximateRankImageFilter< TInputImage, TOutputImage >A separable rank filter
itk::FastChamferDistanceImageFilter< TInputImage, TOutputImage >This class compute the signed (positive and negative) chamfer distance in a narrow band
itk::FastIncrementalBinaryDilateImageFilter< TInputImage, TOutputImage, TKernel >Fast binary dilation
itk::FastMarchingBase< TInput, TOutput >Abstract class to solve an Eikonal based-equation using Fast Marching Method
itk::FastMarchingExtensionImageFilter< TLevelSet, TAuxValue, VAuxDimension, TSpeedImage >Extend auxiliary variables smoothly using Fast Marching
itk::FastMarchingExtensionImageFilterBase< TInput, TOutput, TAuxValue, VAuxDimension >Extend auxiliary variables smoothly using Fast Marching
itk::FastMarchingImageFilter< TLevelSet, TSpeedImage >Solve an Eikonal equation using Fast Marching
itk::FastMarchingImageFilterBase< TInput, TOutput >Fast Marching Method on Image
itk::FastMarchingImageToNodePairContainerAdaptor< TInput, TOutput, TImage >Convenient adaptor class which converts Image into FastMarching::NodePairContainerType used for initializing the FastMarching
itk::FastMarchingNumberOfElementsStoppingCriterion< TInput, TOutput >Stopping Criterion is verified when Current Number of Elements is equal to or greater than the provided Target Number Of Elements
itk::FastMarchingQuadEdgeMeshFilterBase< TInput, TOutput >Fast Marching Method on QuadEdgeMesh
itk::FastMarchingReachedTargetNodesStoppingCriterion< TInput, TOutput >Stopping criterion for FastMarchingFilterBase
itk::FastMarchingStoppingCriterionBase< TInput, TOutput >Abstract Stopping Criterion dedicated for Fast Marching Methods
itk::FastMarchingThresholdStoppingCriterion< TInput, TOutput >Stopping Criterion is verified when Current Value is equal to or greater than the provided threshold
itk::FastMarchingTraits< TInput, TOutput >Base class traits to be used by the FastMarchingBase
itk::FastMarchingTraits< Image< TInputPixel, VDimension >, Image< TOutputPixel, VDimension > >
itk::FastMarchingTraits< QuadEdgeMesh< TInputPixel, VDimension, TInputMeshTraits >, QuadEdgeMesh< TOutputPixel, VDimension, TOutputMeshTraits > >
itk::FastMarchingTraitsBase< TInputDomain, TNode, TOutputDomain, TSuperclass >
itk::FastMarchingUpwindGradientImageFilter< TLevelSet, TSpeedImage >Generates the upwind gradient field of fast marching arrival times
itk::FastMarchingUpwindGradientImageFilterBase< TInput, TOutput >Generates the upwind gradient field of fast marching arrival times
itk::FastMutexLockCritical section locking class
itk::FastSymmetricForcesDemonsRegistrationFilter< TFixedImage, TMovingImage, TDisplacementField >Deformably register two images using a symmetric forces demons algorithm
itk::FastSymmetricForcesDemonsRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >
itk::FiniteDifferenceSparseImageFilter< TInputImageType, TSparseOutputImageType >::FDThreadStruct
itk::MRCHeaderObject::FeiExtendedHeader
itk::fem::FEMExceptionBase class for all exception's that can occur within FEM classes
itk::fem::FEMExceptionIOBase class for all IO exception's that can occur within FEM classe
itk::fem::FEMExceptionItpackSolverHandles errors that occur in itpack solving routines
itk::fem::FEMExceptionItpackSparseMatrixSbagnHandles errors that occur when unfinalizing the matrix
itk::fem::FEMExceptionItpackSparseMatrixSbsijHandles errors that occur when building the matrix
itk::fem::FEMExceptionLinearSystem
itk::fem::FEMExceptionLinearSystemBounds
itk::fem::FEMExceptionObjectNotFoundObject not found exception
itk::fem::FEMExceptionSolutionBase class for all exceptions that can occur when solving FEM problem
itk::fem::FEMExceptionWrongClassBad object exception
itk::FEMFactory< T >Create instances of FEM Objects This includes Elements, Loads, and Materials
itk::FEMFactoryBaseCreate instances of FEM Objects. This includes Elements, Loads, and Materials
itk::fem::FEMLightObjectBase class for all classes that define the FEM system
itk::fem::FEMObject< VDimension >Implements N-dimensional Finite element (FE) models including elements, materials, and loads
itk::FEMObjectSpatialObject< TDimension >Implementation spatial object that can hold a FEMObject
itk::fem::FEMP< T >Pointer used to store polymorphic elements in STL arrays
itk::fem::FEMPArray< T >Array for FEMP objects
itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >FEM Image registration filter. The image registration problem is modeled here with the finite element method. Image registration is, in general, an ill-posed problem. Thus, we use an optimization scheme where the optimization criterion is given by a regularized variational energy. The variational energy arises from modeling the image as a physical body on which external forces act. The body is allowed to deform so as to minimize the applied force. The resistance of the physical body to deformation, determined by the physics associated with the body, serves to regularize the solution. The forces applied to the body are, generally, highly non-linear and so the body is allowed to deform slowly and incrementally. The direction it deforms follows the gradient of the potential energy (the force) we define. The potential energies we may choose from are given by the itk image-to-image metrics. The choices and the associated direction of descent are : Mean Squares (minimize), Normalized Cross-Correlation (maximize), and Mutual Information (maximize). Note that we have to set the direction (SetDescentDirection) when we choose a metric
itk::FEMSpatialObjectReader< NDimensions, PixelType, TMeshTraits >Read any SpatialObject file with conversion for FEM Objects
itk::FEMSpatialObjectWriter< NDimensions, PixelType, TMeshTraits >Read any SpatialObject file with conversion for FEM Objects
itk::Functor::FeretDiameterLabelObjectAccessor< TLabelObject >
itk::FFTComplexToComplexImageFilter< TImage >Implements an API to enable the Fourier transform or the inverse Fourier transform of images with complex valued voxels to be computed
itk::FFTConvolutionImageFilter< TInputImage, TKernelImage, TOutputImage, TInternalPrecision >Convolve a given image with an arbitrary image kernel using multiplication in the Fourier domain
itk::FFTNormalizedCorrelationImageFilter< TInputImage, TOutputImage >Calculate normalized cross correlation using FFTs
itk::FFTShiftImageFilter< TInputImage, TOutputImage >Shift the zero-frequency components of a Fourier transfrom to the center of the image
itk::FFTWComplexToComplexImageFilter< TImage >Implements an API to enable the Fourier transform or the inverse Fourier transform of images with complex valued voxels to be computed using either FFTW from MIT or the FFTW interface in Intel MKL. This filter is multithreaded and supports input images with sizes which are not a power of two
itk::FFTWForwardFFTImageFilter< TInputImage, TOutputImage >FFTW-based forward Fast Fourier Transform
itk::FFTWGlobalConfiguration
itk::FFTWHalfHermitianToRealInverseFFTImageFilter< TInputImage, TOutputImage >FFTW-based reverse Fast Fourier Transform
itk::FFTWInverseFFTImageFilter< TInputImage, TOutputImage >FFTW-based inverse Fast Fourier Transform
itk::FFTWRealToHalfHermitianForwardFFTImageFilter< TInputImage, TOutputImage >FFTW-based forward Fast Fourier Transform
itk::FileListVideoIOVideoIO object for reading and writing videos as a sequence of frame files
itk::FileListVideoIOFactoryCreate instances of FileListVideoIO objects using an object factory
itk::FileOutputWindowMessages sent from the system are sent to a file
itk::ProgressAccumulator::FilterRecord
FilterWatcher
itk::FiniteCylinderSpatialFunction< VDimension, TInput >Function implementation of an finite cylinder
itk::FiniteDifferenceFunction< TImageType >
itk::fem::FiniteDifferenceFunctionLoad< TMoving, TFixed >General image pair load that uses the itkFiniteDifferenceFunctions
itk::FiniteDifferenceImageFilter< TInputImage, TOutputImage >
itk::FiniteDifferenceSparseImageFilter< TInputImageType, TSparseOutputImageType >This class implements a multi-threaded base class for Image to SparseImage finite difference processes
itk::FiniteDifferenceSparseImageFunction< TSparseImageType >This is the base class for function classes that can be used with filters derived from FiniteDifferenceSparseImageFilter
itk::FixedArray< TValueType, VLength >Simulate a standard C array with copy semnatics
itk::FixedCenterOfRotationAffineTransform< TScalarType, NDimensions >Affine transformation with a specified center of rotation
itk::ImageToImageMetric< TFixedImage, TMovingImage >::FixedImageSamplePoint
itk::watershed::Boundary< TScalarType, TDimension >::flat_region_t
itk::watershed::Segmenter< TInputImage >::flat_region_t
itk::Functor::FlatnessLabelObjectAccessor< TLabelObject >
itk::FlatStructuringElement< VDimension >A class to support a variety of flat structuring elements, including versions created by decomposition of lines
itk::FlipImageFilter< TImage >Flips an image across user specified axes
itk::FloatingPointExceptions
itk::Concept::FloatOrDouble< double >
itk::Concept::FloatOrDouble< float >
itk::FloodFilledFunctionConditionalConstIterator< TImage, TFunction >Iterates over a flood-filled spatial function
itk::FloodFilledImageFunctionConditionalConstIterator< TImage, TFunction >Iterates over a flood-filled image function with read-only access to pixels
itk::FloodFilledImageFunctionConditionalIterator< TImage, TFunction >Iterates over a flood-filled image function with write access to pixels
itk::FloodFilledSpatialFunctionConditionalConstIterator< TImage, TFunction >Iterates over a flood-filled spatial function with read-only access to pixels
itk::FloodFilledSpatialFunctionConditionalIterator< TImage, TFunction >Iterates over a flood-filled spatial function with write access to pixels
itk::VoronoiDiagram2DGenerator< TCoordType >::FortuneEdge
itk::VoronoiDiagram2DGenerator< TCoordType >::FortuneHalfEdge
itk::VoronoiDiagram2DGenerator< TCoordType >::FortuneSite
itk::ForwardDifferenceOperator< TPixel, VDimension, TAllocator >Operator whose inner product with a neighborhood returns a "half" derivative at the center of the neighborhood
itk::ForwardFFTImageFilter< TInputImage, TOutputImage >Base class for forward Fast Fourier Transform
itk::FourierSeriesPath< VDimension >Represent a closed path through ND Space by its frequency components
itk::FrameAverageVideoFilter< TInputVideoStream, TOutputVideoStream >Average frames over a designated range in a video
itk::FrameDifferenceVideoFilter< TInputVideoStream, TOutputVideoStream >Compute the squared intensity difference between frame x and frame x+n
itk::FreeSurferAsciiMeshIOThis class defines how to read and write freesurfer ASCII surface format. To use IO factory, define the suffix as *.fsa
itk::FreeSurferAsciiMeshIOFactoryCreate instances of FreeSurferAsciiMeshIO objects using an object factory
itk::FreeSurferBinaryMeshIOThis class defins how to read Freesurfer binary surface file format. To use IO factory, define the suffix as *.fsb
itk::FreeSurferBinaryMeshIOFactoryCreate instances of FreeSurferBinaryMeshIO objects using an object factory
itk::QuadEdgeMeshFrontBaseIterator< TMesh, TQE >::FrontAtomAtomic information associated to each edge of the front
itk::FRPROptimizerImplements Fletch-Reeves & Polak-Ribiere optimization using dBrent line search
itk::FrustumSpatialFunction< VImageDimension, TInput >Spatial function implementation of a truncated pyramid
itk::FullToHalfHermitianImageFilter< TInputImage >Reduces the size of a full complex image produced from a forward discrete Fourier transform of a real image to only the non-redundant half of the image
itk::FunctionAndGradientEvaluationIterationEvent
itk::FunctionBase< TInput, TOutput >Base class for all ITK function objects
itk::FunctionEvaluationIterationEvent
itk::GaborImageSource< TOutputImage >Generate an n-dimensional image of a Gabor filter
itk::GaborKernelFunction< TRealValueType >Gabor kernel used for various computer vision tasks
itk::GaussianBlurImageFunction< TInputImage, TOutput >Compute the convolution of a neighborhood operator with the image at a specific location in space, i.e. point, index or continuous index. This class is templated over the input image type
itk::GaussianDerivativeImageFunction< TInputImage, TOutput >Compute the gaussian derivatives of an the image at a specific location in space, i.e. point, index or continuous index. This class is templated over the input image type
itk::GaussianDerivativeOperator< TPixel, VDimension, TAllocator >A NeighborhoodOperator whose coefficients are a one dimensional, discrete derivative Gaussian kernel
itk::GaussianDerivativeSpatialFunction< TOutput, VImageDimension, TInput >N-dimensional Gaussian spatial function class
itk::Statistics::GaussianDistributionGaussianDistribution class defines the interface for a univariate Gaussian distribution (pdfs, cdfs, etc.)
itk::GaussianImageSource< TOutputImage >Generate an n-dimensional image of a Gaussian
itk::GaussianInterpolateImageFunction< TInputImage, TCoordRep >Evaluates the Gaussian interpolation of an image
itk::GaussianKernelFunction< TRealValueType >Gaussian kernel used for density estimation and nonparameteric regression
itk::Statistics::GaussianMembershipFunction< TMeasurementVector >GaussianMembershipFunction models class membership through a multivariate Gaussian function
itk::Statistics::GaussianMixtureModelComponent< TSample >Component (derived from MixtureModelComponentBase) for Gaussian class. This class is used in ExpectationMaximizationMixtureModelEstimator
itk::GaussianOperator< TPixel, VDimension, TAllocator >A NeighborhoodOperator whose coefficients are a one dimensional, discrete Gaussian kernel
itk::Statistics::GaussianRadialBasisFunction< ScalarType >This is the itkGaussianRadialBasisFunction class
itk::GaussianSmoothingOnUpdateDisplacementFieldTransform< TScalar, NDimensions >Modifies the UpdateTransformParameters method to peform a Gaussian smoothing of the displacement field after adding the update array
itk::GaussianSmoothingOnUpdateDisplacementFieldTransformParametersAdaptor< TTransform >Helper class for multiresolution image registration
itk::GaussianSmoothingOnUpdateTimeVaryingVelocityFieldTransform< TScalar, NDimensions >Modifies the UpdateTransformParameters method to peform a Gaussian smoothing of the velocity field after adding the update array
itk::GaussianSpatialFunction< TOutput, VImageDimension, TInput >N-dimensional gaussian spatial function class
itk::GaussianSpatialObject< TDimension >Represents a multivariate Gaussian function
itk::Statistics::GaussianTransferFunction< ScalarType >This is the itkGaussianTransferFunction class
itk::fem::GaussIntegrateUse the Gauss-Legendre formula to perform integration
itk::GDCMImageIOImageIO class for reading and writing DICOM V3.0 and ACR/NEMA 1&2 uncompressed images This class is only an adaptor to the gdcm library (currently gdcm 1.2.x is used by default):
itk::GDCMImageIOFactoryCreate instances of GDCMImageIO objects using an object factory
itk::GDCMSeriesFileNamesGenerate a sequence of filenames from a DICOM series
itk::GE4ImageIOClass that defines how to read GE4 file format
itk::GE4ImageIOFactoryCreate instances of GE4ImageIO objects using an object factory
itk::GE5ImageIOClass that defines how to read GE5 file format
itk::GE5ImageIOFactoryCreate instances of GE5ImageIO objects using an object factory
GE_5x_ImgHdr
itk::GEAdwImageIOClass that defines how to read GEAdw file format
itk::GEAdwImageIOFactoryCreate instances of GEAdwImageIO objects using an object factory
GEImageHeader
itk::bio::GeneThis class implements the abstraction of a biological gene
itk::bio::GeneNetworkThis class implements the abstraction of a biological gene network
itk::GenerateImageSource< TOutputImage >Base class for image sources which need to have image size, and other meta-data set
itk::bio::GenomeThis class implements the abstraction of a biological genome
itk::GeodesicActiveContourLevelSetFunction< TImageType, TFeatureImageType >This function is used in GeodesicActiveContourLevelSetImageFilter to segment structures in an image based on a user supplied edge potential map
itk::GeodesicActiveContourLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on a user supplied edge potential map
itk::GeodesicActiveContourShapePriorLevelSetFunction< TImageType, TFeatureImageType >This function is used in GeodesicActiveContourShapePriorSegmentationLevelSetFilter to segment structures in an image based on user supplied edge potential map and shape model
itk::GeodesicActiveContourShapePriorLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in an image based on a user supplied edge potential map and user supplied shape model
itk::GeometricalQuadEdge< TVRef, TFRef, TPrimalData, TDualData, PrimalDual >This class extends the QuadEdge by adding a reference to the Origin
itk::GeometryUtilitiesGroups some utility functions related to geometry
itk::GetAverageSliceImageFilter< TInputImage, TOutputImage >Averages a single dimension of an image
itk::GetDimension< T >
itk::Statistics::GetHistogramDimension< THistogram >
itk::GetImageDimension< TImage >
itk::GetMeshDimension< TMesh >
itk::GetPointSetDimension< TPointSet >
itk::GetVectorDimension< TVector >
itk::GiftiMeshIOThis class defines how to read and write Gifti file format
itk::GiftiMeshIOFactoryCreate instances of GiftiMeshIO objects using an object factory
itk::GiplImageIORead GiplImage file format
itk::GiplImageIOFactoryCreate instances of GiplImageIO objects using an object factory
itk::ESMDemonsRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >::GlobalDataStruct
itk::RegionBasedLevelSetFunction< TInput, TFeature, TSharedData >::GlobalDataStruct
itk::LevelSetFunction< TImageType >::GlobalDataStruct
itk::MeanSquareRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >::GlobalDataStruct
itk::DemonsRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >::GlobalDataStruct
itk::FastSymmetricForcesDemonsRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >::GlobalDataStruct
itk::LevelSetMotionRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >::GlobalDataStruct
itk::SymmetricForcesDemonsRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >::GlobalDataStruct
itk::MIRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >::GlobalDataStruct
itk::NCCRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >::GlobalDataStruct
itk::GradientAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >
itk::GradientDescentOptimizerImplement a gradient descent optimizer
itk::GradientDescentOptimizerBasev4Abstract base class for gradient descent-style optimizers
itk::GradientDescentOptimizerBasev4ModifyGradientByLearningRateThreaderModify the gradient by the learning rate for GradientDescentOptimizerBasev4
itk::GradientDescentOptimizerBasev4ModifyGradientByScalesThreaderModify the gradient by the parameter scales for GradientDescentOptimizerBasev4
itk::GradientDescentOptimizerv4Gradient descent optimizer
itk::GradientDifferenceImageToImageMetric< TFixedImage, TMovingImage >Computes similarity between two objects to be registered
itk::GradientEvaluationIterationEvent
itk::GradientImageFilter< TInputImage, TOperatorValueType, TOutputValueType >Computes the gradient of an image using directional derivatives
itk::GradientMagnitudeImageFilter< TInputImage, TOutputImage >Computes the gradient magnitude of an image region at each pixel
itk::GradientMagnitudeRecursiveGaussianImageFilter< TInputImage, TOutputImage >Computes the Magnitude of the Gradient of an image by convolution with the first derivative of a Gaussian
itk::GradientNDAnisotropicDiffusionFunction< TImage >
itk::GradientRecursiveGaussianImageFilter< TInputImage, TOutputImage >Computes the gradient of an image by convolution with the first derivative of a Gaussian
itk::GradientToMagnitudeImageFilter< TInputImage, TOutputImage >Take an image of vectors as input and produce an image with the magnitude of those vectors
itk::GradientVectorFlowImageFilter< TInputImage, TOutputImage, TInternalPixel >This class computes a diffusion of the gradient vectors for graylevel or binary edge map derive from the image. It enlarges the capture range of the gradient force and make external force derived from the gradient work effectively in the framework of deformable model
itk::GrayscaleConnectedClosingImageFilter< TInputImage, TOutputImage >Enhance pixels associated with a dark object (identified by a seed pixel) where the dark object is surrounded by a brigher object
itk::GrayscaleConnectedOpeningImageFilter< TInputImage, TOutputImage >Enhance pixels associated with a bright object (identified by a seed pixel) where the bright object is surrounded by a darker object
itk::GrayscaleDilateImageFilter< TInputImage, TOutputImage, TKernel >Gray scale dilation of an image
itk::GrayscaleErodeImageFilter< TInputImage, TOutputImage, TKernel >Gray scale dilation of an image
itk::GrayscaleFillholeImageFilter< TInputImage, TOutputImage >Remove local minima not connected to the boundary of the image
itk::GrayscaleFunctionDilateImageFilter< TInputImage, TOutputImage, TKernel >Gray scale function dilation of an image
itk::GrayscaleFunctionErodeImageFilter< TInputImage, TOutputImage, TKernel >Gray scale function erosion of an image
itk::GrayscaleGeodesicDilateImageFilter< TInputImage, TOutputImage >Geodesic gray scale dilation of an image
itk::GrayscaleGeodesicErodeImageFilter< TInputImage, TOutputImage >Geodesic gray scale erosion of an image
itk::GrayscaleGrindPeakImageFilter< TInputImage, TOutputImage >Remove local maxima not connected to the boundary of the image
itk::GrayscaleMorphologicalClosingImageFilter< TInputImage, TOutputImage, TKernel >Gray scale dilation of an image
itk::GrayscaleMorphologicalOpeningImageFilter< TInputImage, TOutputImage, TKernel >Gray scale dilation of an image
itk::Concept::GreaterThanComparable< T1, T2 >
itk::Function::GreenColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::GreenPixelAccessor< T >Give access to the Green component of a RGBPixel type
itk::AttributeMorphologyBaseImageFilter< TInputImage, TOutputImage, TAttribute, TFunction >::GreyAndPos
itk::Function::GreyColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::GridForwardWarpImageFilter< TDisplacementField, TOutputImage >Warps a grid using an input deformation field
itk::GridImageSource< TOutputImage >Generate an n-dimensional image of a grid
itk::GroupSpatialObject< TDimension >Representation of a group based on the spatial object classes
itk::HalfHermitianToRealInverseFFTImageFilter< TInputImage, TOutputImage >Base class for specialized complex-to-real inverse Fast Fourier Transform
itk::HalfToFullHermitianImageFilter< TInputImage >Expands a half image produced from a real-to-complex discrete Fourier transform (DFT) to the full complex image
itk::Function::HammingWindowFunction< VRadius, TInput, TOutput >Window function for sinc interpolation.

\[ w(x) = 0.54 + 0.46 cos(\frac{\pi x}{m} ) \]

itk::HardConnectedComponentImageFilter< TInputImage, TOutputImage >
itk::Statistics::HardLimitTransferFunction< ScalarType >This is the itkHardLimitTransferFunction class
itk::HardwareWisdomFilenameGenerator
itk::HarmonicMatrixCoefficients< TInputMesh >Compute a matrix filled with Harmonic coefficients, wherever two vertices are connected by an edge
itk::Testing::HashImageFilter< TImageType >Generates a md5 hash string from an image
itk::Concept::HasJoinTraits< T1, T2 >
itk::Concept::HasNumericTraits< T >
itk::Concept::HasPixelTraits< T >
itk::Concept::HasValueType< T >
itk::Concept::HasZero< T >
itk::HausdorffDistanceImageFilter< TInputImage1, TInputImage2 >Computes the Hausdorff distance between the set of non-zero pixels of two images
itk::HConcaveImageFilter< TInputImage, TOutputImage >Identify local minima whose depth below the baseline is greater than h
itk::HConvexImageFilter< TInputImage, TOutputImage >Identify local maxima whose height above the baseline is greater than h
itk::HDF5ImageIOClass that defines how to read HDF5 file format. HDF5 IMAGE FILE FORMAT - As much information as I can determine from sourceforge.net/projects/HDF5lib
itk::HDF5ImageIOFactoryCreate instances of HDF5ImageIO objects using an object factory
itk::HDF5TransformIORead&Write transforms in HDF5 Format
itk::HDF5TransformIOFactoryCreate instances of HDF5TransformIO objects using an object factory
itk::MRCHeaderObject::Header
itk::HeavisideStepFunction< TInput, TOutput >Implementation of the classical Heaviside step function
itk::HeavisideStepFunctionBase< TInput, TOutput >Base class of the Heaviside function
itk::Hessian3DToVesselnessMeasureImageFilter< TPixel >Line filter to provide a vesselness measure for tubular objects from the hessian matrix
itk::HessianRecursiveGaussianImageFilter< TInputImage, TOutputImage >Computes the Hessian matrix of an image by convolution with the Second and Cross derivatives of a Gaussian
itk::HessianToObjectnessMeasureImageFilter< TInputImage, TOutputImage >A filter to enhance M-dimensional objects in N-dimensional images
itk::HexahedronCell< TCellInterface >Represents a hexahedron for a Mesh
itk::HexahedronCellTopologyHolds data defining the topological connections of the vertices and edges of a HexahedronCell
itk::HilbertPath< TIndexValue, VDimension >Represent an n-dimensional Hilbert path for a given order
itk::Statistics::Histogram< TMeasurement, TFrequencyContainer >This class stores measurement vectors in the context of n-dimensional histogram
itk::HistogramAlgorithmBase< TInputHistogram >Base class for algorithms operating on histograms
itk::Function::HistogramEntropyFunction< TInput, TOutput >
itk::HistogramImageToImageMetric< TFixedImage, TMovingImage >Computes similarity between two objects to be registered
itk::Function::HistogramIntensityFunction< TInput, TOutput >
itk::Functor::HistogramLabelObjectAccessor< TLabelObject >
itk::Function::HistogramLogProbabilityFunction< TInput, TOutput >
itk::HistogramMatchingImageFilter< TInputImage, TOutputImage, THistogramMeasurement >Normalize the grayscale values between two images by histogram matching
itk::Function::HistogramProbabilityFunction< TInput, TOutput >
itk::HistogramThresholdCalculator< THistogram, TOutput >Base class to compute a threshold value based on the histogram of an image
itk::HistogramThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using a HistogramThresholdCalculator
itk::HistogramToEntropyImageFilter< THistogram, TImage >The class takes a histogram as an input and gives the entropy image as the output. A pixel, at position I, in the output image is given by
itk::HistogramToImageFilter< THistogram, TImage, TFunction >This class takes a histogram as an input and returns an image of type specified by the functor
itk::HistogramToIntensityImageFilter< THistogram, TImage >The class takes a histogram as an input and produces an image as the output. A pixel, at position I, in the output image is given by
itk::HistogramToLogProbabilityImageFilter< THistogram, TImage >The class takes a histogram as an input and gives the log probability image as the output. A pixel, at position I, in the output image is given by
itk::HistogramToProbabilityImageFilter< THistogram, TImage >The class takes a histogram as an input and gives the probability image as the output. A pixel, at position I, in the output image is given by
itk::Statistics::HistogramToRunLengthFeaturesFilter< THistogram >This class computes texture feature coefficients from a grey level run-length matrix
itk::Statistics::HistogramToTextureFeaturesFilter< THistogram >This class computes texture feature coefficients from a grey level co-occurrence matrix
itk::HMaximaImageFilter< TInputImage, TOutputImage >Suppress local maxima whose height above the baseline is less than h
itk::HMinimaImageFilter< TInputImage, TOutputImage >Suppress local minima whose depth below the baseline is less than h
itk::HostnameWisdomFilenameGenerator
itk::Function::HotColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::HoughTransform2DCirclesImageFilter< TInputPixelType, TOutputPixelType >Performs the Hough Transform to find circles in a 2D image
itk::HoughTransform2DLinesImageFilter< TInputPixelType, TOutputPixelType >Performs the Hough Transform to find 2D straight lines in a 2D image
itk::Function::HSVColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::HuangThresholdCalculator< THistogram, TOutput >Computes the Huang's threshold for an image
itk::HuangThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the Huang Threshold
itk::AutomaticTopologyMeshSource< TOutputMesh >::IdentifierArrayEqualsFunction
itk::AutomaticTopologyMeshSource< TOutputMesh >::IdentifierArrayHashFunction
itk::Statistics::IdentityTransferFunction< ScalarType >This is the itkIdentityTransferFunction class
itk::IdentityTransform< TScalarType, NDimensions >Implementation of an Identity Transform
itk::Image< TPixel, VImageDimension >Templated n-dimensional image class
itk::ImageAdaptor< TImage, TAccessor >Give access to partial aspects of voxels from an Image
itk::ImageAlgorithmA container of static functions which can operate on Images with Iterators
itk::ImageAndPathToImageFilter< TInputImage, TInputPath, TOutputImage >Base class for filters that take both a path and an image as input and produce a path as output
itk::ImageBase< VImageDimension >Base class for templated image classes
itk::ImageBoundaryCondition< TInputImage, TOutputImage >A virtual base object that defines an interface to a class of boundary condition objects for use by neighborhood iterators
itk::NeighborhoodAlgorithm::ImageBoundaryFacesCalculator< TImage >Splits an image into a main region and several "face" regions which are used to handle computations on the boundary of an image
itk::ImageClassifierBase< TInputImage, TClassifiedImage >Base class for the ImageClassifierBase object
itk::Statistics::ImageClassifierFilter< TSample, TInputImage, TOutputImage >Image classification class
itk::ImageConstIterator< TImage >A multi-dimensional image iterator templated over image type
itk::ImageConstIteratorWithIndex< TImage >A base class for multi-dimensional iterators templated over image type that are designed to efficiently keep track of the iterator position
itk::ImageContainerInterface< TElementIdentifier, TElement >Used for reference when writing containers conforming to this interface
itk::ImageDuplicator< TInputImage >A helper class which creates an image which is perfect copy of the input image
itk::ImageFileReader< TOutputImage, ConvertPixelTraits >Data source that reads image data from a single file
itk::ImageFileReaderExceptionBase exception class for IO conflicts
itk::ImageFileWriter< TInputImage >Writes image data to a single file
itk::ImageFileWriterExceptionBase exception class for IO problems during writing
itk::ImageFilterToVideoFilterWrapper< TImageToImageFilter >Wrap an ImageToImageFilter as a VideoToVideoFilter that operates on a single frame at a time
itk::ImageFunction< TInputImage, TOutput, TCoordRep >Evaluates a function of an image at specified position
itk::ImageGaussianModelEstimator< TInputImage, TMembershipFunction, TTrainingImage >Base class for ImageGaussianModelEstimator object
itk::ImageHelper< NImageDimension, NLoop >Fast Index/Offset computation
itk::ImageIOBaseAbstract superclass defines image IO interface
itk::ImageIOFactoryCreate instances of ImageIO objects using an object factory
itk::ImageIORegionAn ImageIORegion represents a structured region of data
itk::ImageIORegionAdaptor< VDimension >Helper class for converting ImageRegions into ImageIORegions and back
itk::ImageIterator< TImage >A multi-dimensional iterator templated over image type
itk::ImageIteratorWithIndex< TImage >A base class for multi-dimensional iterators templated over image type that are designed to efficiently keep track of the iterator position
itk::Statistics::ImageJointDomainTraits< TImage >This class provides the type defintion for the measurement vector in the joint domain (range domain -- pixel values + spatial domain -- pixel's physical coordinates)
itk::ImageKernelOperator< TPixel, VDimension, TAllocator >A NeighborhoodOperator whose coefficients are from an image
itk::ImageKmeansModelEstimator< TInputImage, TMembershipFunction >Base class for ImageKmeansModelEstimator object
itk::ImageLinearConstIteratorWithIndex< TImage >A multi-dimensional image iterator that visits image pixels within a region in a "scan-line" order
itk::ImageLinearIteratorWithIndex< TImage >A multi-dimensional image iterator that visits image pixels within a region in a "scan-line" order
itk::ImageMaskSpatialObject< TDimension >Implementation of an image mask as spatial object
itk::fem::ImageMetricLoad< TMoving, TFixed >General image pair load that uses the itkImageToImageMetrics
itk::ImageModelEstimatorBase< TInputImage, TMembershipFunction >Base class for model estimation from images used for classification
itk::ImageMomentsCalculator< TImage >Compute moments of an n-dimensional image
itk::ImagePCADecompositionCalculator< TInputImage, TBasisImage >Decomposes an image into directions along basis components
itk::ImagePCAShapeModelEstimator< TInputImage, TOutputImage >Base class for ImagePCAShapeModelEstimator object
itk::ImageRandomConstIteratorWithIndex< TImage >A multi-dimensional image iterator that visits a random set of pixels within an image region
itk::ImageRandomIteratorWithIndex< TImage >A multi-dimensional image iterator that visits a random set of pixels within an image region
itk::ImageRandomNonRepeatingConstIteratorWithIndex< TImage >A multi-dimensional image iterator that visits a random set of pixels within an image region. All pixels in the image will be visited before any are repeated. A priority image may be passed to the interator which will cause it to select certain sets of pixels (those with lower priority values) before others
itk::ImageRandomNonRepeatingIteratorWithIndex< TImage >A multi-dimensional image iterator that visits image pixels within a region in a random order, without repeating
itk::ImageRegion< VImageDimension >An image region represents a structured region of data
itk::ImageRegionConstIterator< TImage >A multi-dimensional iterator templated over image type that walks a region of pixels
itk::ImageRegionConstIteratorWithIndex< TImage >A multi-dimensional iterator templated over image type that walks an image region and is specialized to keep track of its index location
itk::ImageToImageFilterDetail::ImageRegionCopier< D1, D2 >A Function object used to dispatching to a routine to copy a region (start index and size)
itk::ImageRegionExclusionConstIteratorWithIndex< TImage >A multi-dimensional image iterator that walks an image region, excluding a second region that may partially or completely overlap the first, with read-only access to pixels
itk::ImageRegionExclusionIteratorWithIndex< TImage >A multi-dimensional image iterator that walks an image region, excluding a second region contained within the first, with write access to pixels
itk::ImageRegionIterator< TImage >A multi-dimensional iterator templated over image type that walks a region of pixels
itk::ImageRegionIteratorWithIndex< TImage >A multi-dimensional iterator templated over image type that walks pixels within a region and is specialized to keep track of its image index location
itk::ImageRegionMultidimensionalSplitter< VImageDimension >Divide a region into several pieces
itk::ImageRegionReverseConstIterator< TImage >A multi-dimensional image iterator designed to walk a specified image region in reverse
itk::ImageRegionReverseIterator< TImage >A multi-dimensional image iterator which only walks a region
itk::ImageRegionSplitter< VImageDimension >Divide a region into several pieces
itk::ImageRegistrationMethod< TFixedImage, TMovingImage >Base class for Image Registration Methods
itk::testhelper::ImageRegistrationMethodImageSource< TFixedPixelType, TMovingPixelType, NDimension >
itk::ImageRegistrationMethodv4< TFixedImage, TMovingImage, TTransform >Interface method for the current registration framework
itk::ImageReverseConstIterator< TImage >Multi-dimensional image iterator
itk::ImageReverseIterator< TImage >A multi-dimensional image iterator designed to walk a specified region in reverse
itk::ImageSeriesReader< TOutputImage >Data source that reads image data from a series of disk files
itk::ImageSeriesWriter< TInputImage, TOutputImage >Writes image data to a series of data files
itk::ImageSeriesWriterExceptionBase exception class for IO problems during writing
itk::ImageShapeModelEstimatorBase< TInputImage, TOutputImage >Base class for statistical shape model estimation
itk::ImageSliceConstIteratorWithIndex< TImage >Multi-dimensional image iterator which only walks a region
itk::ImageSliceIteratorWithIndex< TImage >A multi-dimensional image iterator that extends the ImageLinearIteratorWithIndex from iteration along lines in an image to iteration along both lines and planes (slices) within an image
itk::ImageSource< TOutputImage >Base class for all process objects that output image data
itk::ImageSpatialObject< TDimension, TPixelType >Implementation of an image as spatial object
itk::Statistics::ImageToHistogramFilter< TImage >This class generates an histogram from an image
itk::ImageToImageFilter< TInputImage, TOutputImage >Base class for filters that take an image as input and produce an image as output
itk::ImageToImageMetric< TFixedImage, TMovingImage >Computes similarity between regions of two images
itk::ImageToImageMetricv4< TFixedImage, TMovingImage, TVirtualImage >
itk::ImageToImageMetricv4GetValueAndDerivativeThreader< TDomainPartitioner, TImageToImageMetricv4 >Provides threading for ImageToImageMetricv4::GetValueAndDerivative
itk::ImageToImageMetricv4GetValueAndDerivativeThreader< ThreadedImageRegionPartitioner< TImageToImageMetricv4::VirtualImageDimension >, TImageToImageMetricv4 >
itk::ImageToImageMetricv4GetValueAndDerivativeThreader< ThreadedIndexedContainerPartitioner, TImageToImageMetricv4 >
itk::ImageToImageMetricv4GetValueAndDerivativeThreaderBase< TDomainPartitioner, TImageToImageMetricv4 >Provides threading for ImageToImageMetricv4::GetValueAndDerivative
itk::Statistics::ImageToListSampleAdaptor< TImage >This class provides ListSample interface to ITK Image
itk::Statistics::ImageToListSampleFilter< TImage, TMaskImage >The class takes an image as input and generates a list sample as output
itk::ImageToMeshFilter< TInputImage, TOutputMesh >ImageToMeshFilter is the base class for all process objects that output Mesh data and require image data as input. Specifically, this class defines the SetInput() method for defining the input to a filter
itk::ImageToParametricSpaceFilter< TInputImage, TOutputMesh >Generate a mesh of parametric space from input images
itk::ImageToPathFilter< TInputImage, TOutputPath >Base class for filters that take an image as input and produce an path as output
itk::fem::ImageToRectilinearFEMObjectFilter< TInputImage >Generate a rectilinar mesh from an image. The result is stored in a FEMObject
itk::ImageToSpatialObjectMetric< TFixedImage, TMovingSpatialObject >Computes similarity between a moving spatial obejct and an Image to be registered
itk::ImageToSpatialObjectRegistrationMethod< TFixedImage, TMovingSpatialObject >Base class for Image Registration Methods
itk::ImageToVectorImageFilter< TInputImage >This class takes as input 'n' itk::Image's and composes them into a single itk::VectorImage
itk::ImageTransformer< TInputImage >Base class for all process objects that transform an image into something else
itk::ImageTransformHelper< NImageDimension, R, C >Fast index/physical index computation
itk::ImageVectorOptimizerParametersHelper< TValueType, NVectorDimension, VImageDimension >Class to hold and manage parameters of type Image<Vector<...>,...>, used in Transforms, etc
itk::ImageVoxel
itk::ImplicitManifoldNormalVectorFilter< TInputImage, TSparseOutputImage >This class implements the filter for computing the normal vectors from a scalar implicit function (i.e. a levelset image) and processing them
itk::ImportImageContainer< TElementIdentifier, TElement >Defines an itk::Image front-end to a standard C-array
itk::ImportImageFilter< TPixel, VImageDimension >Import data from a standard C array into an itk::Image
itk::IncompatibleOperandsError
itk::Concept::IncrementDecrementOperators< T >
itk::IndentControl indentation during Print() invocation
itk::Index< VIndexDimension >Represent a n-dimensional index in a n-dimensional image
itk::IndexedContainerInterface< TElementIdentifier, TElement >This should only be used for reference when writing containers conforming to this interface. This should only be used for reference when writing containers conforming to this interface. ITK uses generic programming to allow container type substitution, so polymorphism is not needed to use containers through this interface. This means that a container conforming to this interface need not be derived from it, and that their methods should not be virtual. However, the container must derive from Object in order to support the reference counting, modification time, and debug information required by this interface
itk::Functor::IndexLexicographicCompare< VIndexDimension >Order Index instances lexicographically
itk::InitializationBiasedParticleSwarmOptimizerImplementation of a biased/regularized Particle Swarm Optimization (PSO) algorithm
itk::InitializeEvent
itk::InOrderTreeIterator< TTreeType >
itk::InPlaceImageFilter< TInputImage, TOutputImage >Base class for filters that take an image as input and overwrite that image as the output
itk::InPlaceLabelMapFilter< TInputImage >Base class for filters that takes an image as input and overwrites that image as the output
itk::InputDataObjectConstIteratorA forward iterator over inputs of a ProcessObject
itk::InputDataObjectIteratorA forward iterator over inputs of a ProcessObject
itk::Statistics::InputFunctionBase< TMeasurementVector, TTargetVector >This is the itkInputFunctionBase class
itk::ImageToImageFilterDetail::IntDispatch< int >Templated class to produce a unique type for each integer
itk::Functor::IntensityLinearTransform< TInput, TOutput >
itk::IntensityWindowingImageFilter< TInputImage, TOutputImage >Applies a linear transformation to the intensity levels of the input Image that are inside a user-defined interval. Values below this interval are mapped to a constant. Values over the interval are mapped to another constant
itk::Functor::IntensityWindowingTransform< TInput, TOutput >
InterfaceWrapper for FFTW API
itk::InteriorExteriorMeshFilter< TInputMesh, TOutputMesh, TSpatialFunction >InteriorExteriorMeshFilter takes an itk::Mesh and extracts from it a Sub-Mesh such that all its points Evaluate > 0 in an itk::SpatialFunction provided by the user
itk::InteriorExteriorSpatialFunction< VDimension, TInput >Returns whether or not a location is "inside" or "outside" a function
itk::IntermodesThresholdCalculator< THistogram, TOutput >Computes the Intermodes's threshold for an image
itk::IntermodesThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the Intermodes Threshold
itk::CorrelationImageToImageMetricv4GetValueAndDerivativeThreader< TDomainPartitioner, TImageToImageMetric, TCorrelationMetric >::InternalCumSumType
itk::InterpolateImageFilter< TInputImage, TOutputImage >Interpolate an image from two N-D images
itk::InterpolateImageFunction< TInputImage, TCoordRep >Base class for all image interpolaters
itk::InterpolateImagePointsFilter< TInputImage, TOutputImage, TCoordType, InterpolatorType >Resamples an image at the coordinates specified by the user
itk::IntrinsicMatrixCoefficients< TInputMesh >Compute a mtrix filled by intrinsic Coefficients of the edge, wherever two vertices are connected by an edge
itk::InvalidArgumentError
itk::InvalidRequestedRegionError
InvalidRequestRegionError
itk::Functor::InverseDeconvolutionFunctor< TInput1, TInput2, TOutput >
itk::InverseDeconvolutionImageFilter< TInputImage, TKernelImage, TOutputImage, TInternalPrecision >The direct linear inverse deconvolution filter
itk::InverseDisplacementFieldImageFilter< TInputImage, TOutputImage >Computes the inverse of a displacement field
itk::InverseEuclideanDistanceMatrixCoefficients< TInputMesh >Compute a matrix filed with the inverse of the euclidian distance wherever two vertices are connected by an edge
itk::InverseFFTImageFilter< TInputImage, TOutputImage >Base class for inverse Fast Fourier Transform
itk::InvertDisplacementFieldImageFilter< TInputImage, TOutputImage >Iteratively estimate the inverse field of a displacement field
itk::Functor::InvertIntensityFunctor< InputPixelType >
itk::InvertIntensityImageFilter< TInputImage, TOutputImage >Invert the intensity of an image
itk::Functor::InvertIntensityTransform< TInput, TOutput >
itk::IOCommonCentralized funtionality for IO classes
itk::IOTestHelper
itk::IPLCommonImageIOClass that defines how to read GE4 file format
itk::Concept::IsFixedPoint< T >
itk::Concept::IsFloatingPoint< T >
itk::Concept::IsInteger< T >
itk::Concept::IsNonInteger< T >
itk::IsoContourDistanceImageFilter< TInputImage, TOutputImage >Compute an approximate distance from an interpolated isocontour to the close grid points
itk::IsoDataThresholdCalculator< THistogram, TOutput >Computes the IsoData threshold for an image. Aka intermeans
itk::IsoDataThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the IsoData Threshold
itk::IsolatedConnectedImageFilter< TInputImage, TOutputImage >Label pixels that are connected to one set of seeds but not another
itk::IsolatedWatershedImageFilter< TInputImage, TOutputImage >Isolate watershed basins using two seeds
itk::IsotropicFourthOrderLevelSetImageFilter< TInputImage, TOutputImage >This class implements the 4th-order level set isotropic diffusion (smoothing) PDE
itk::IterationEvent
itk::IterationReporterImplements iterations tracking for a filter
itk::IterativeDeconvolutionImageFilter< TInputImage, TKernelImage, TOutputImage >Abstract base class for filters that implement iterative deconvolution algorithms
itk::IterativeInverseDisplacementFieldImageFilter< TInputImage, TOutputImage >Computes the inverse of a displacement field
itk::Statistics::IterativeSupervisedTrainingFunction< TSample, TTargetVector, ScalarType >This is the itkIterativeSupervisedTrainingFunction class
itk::MapContainer< TElementIdentifier, TElement >::IteratorThe non-const iterator type for the map
itk::LevelSetContainerBase< TIdentifier, TLevelSet >::Iterator
itk::LevelSetEquationContainerBase< TTermContainer >::Iterator
itk::LevelSetEquationTermContainerBase< TInputImage, TLevelSetContainer >::Iterator
itk::VectorContainer< TElementIdentifier, TElement >::Iterator
itk::Statistics::VectorContainerToListSampleAdaptor< TVectorContainer >::Iterator
itk::LabelMap< TLabelObject >::IteratorA forward iterator over the LabelObjects of a LabelMap
itk::Statistics::ImageToListSampleAdaptor< TImage >::IteratorIterator
itk::Statistics::JointDomainImageToListSampleAdaptor< TImage >::IteratorIterator
itk::Statistics::ListSample< TMeasurementVector >::IteratorIterator
itk::IndexedContainerInterface< TElementIdentifier, TElement >::IteratorSupport iteration operations through a container. Dereferencing the iterator must provide an object with the following methods: ElementIdentifier Index(void) const; Element& Value(void);
itk::Statistics::MembershipSample< TSample >::Iterator
itk::Statistics::PointSetToListSampleAdaptor< TPointSet >::Iterator
itk::Statistics::Subsample< TSample >::Iterator
itk::ShapedNeighborhoodIterator< TImage, TBoundaryCondition >::Iterator
itk::Statistics::Histogram< TMeasurement, TFrequencyContainer >::IteratorClass that walks through the elements of the histogram
itkBSplineCenteredL2ResampleImageFilterBaseUses the "Centered L2" B-Spline pyramid implementation of B-Spline Filters to up/down sample an image by a factor of 2
itkFloatingPointExceptions
itkTreeIteratorCloneItkTreeIteratorClone class
itk::fem::ItpackSparseMatrixCompressed row sparse matrix representation that makes use of itpack to dynamically assemble the matrix
itk::JensenHavrdaCharvatTsallisPointSetToPointSetMetricv4< TPointSet >Implementation of the Jensen Havrda Charvat Tsallis Point Set metric
itk::Function::JetColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::Functor::JoinFunctor< TPixel1, TPixel2 >Join the components of two pixel types into a single pixel type
itk::JoinImageFilter< TInputImage1, TInputImage2 >Join two images, resulting in an image where each pixel has the components of the first image followed by the components of the second image
itk::JoinSeriesImageFilter< TInputImage, TOutputImage >Join N-D images into an (N+1)-D image
itk::Statistics::JointDomainImageToListSampleAdaptor< TImage >This adaptor returns measurement vectors composed of an image pixel's range domain value (pixel value) and spatial domain value (pixel's physical coordiantes)
itk::JointHistogramMutualInformationComputeJointPDFThreader< TDomainPartitioner, TJointHistogramMetric >Provide a threaded computation of the joint PDF for JointHistogramMutualInformationImageToImageMetricv4
itk::JointHistogramMutualInformationComputeJointPDFThreader< ThreadedImageRegionPartitioner< TJointHistogramMetric::VirtualImageDimension >, TJointHistogramMetric >
itk::JointHistogramMutualInformationComputeJointPDFThreader< ThreadedIndexedContainerPartitioner, TJointHistogramMetric >
itk::JointHistogramMutualInformationComputeJointPDFThreaderBase< TDomainPartitioner, TJointHistogramMetric >Comput the JointPDF image
itk::JointHistogramMutualInformationGetValueAndDerivativeThreader< TDomainPartitioner, TImageToImageMetric, TJointHistogramMetric >Processes points for JointHistogramMutualInformationImageToImageMetricv4 GetValueAndDerivative()
JointHistogramMutualInformationImageToImageMetricComputes the mutual information between two images to be registered using the method of Mattes et al
itk::JointHistogramMutualInformationImageToImageMetricv4< TFixedImage, TMovingImage, TVirtualImage >
itk::JoinTraits< TValueType1, TValueType2 >Trait to determine what datatype is needed if the specified pixel types are "joined" into a single vector
itk::JPEG2000ImageIOSupports for the JPEG2000 file format based on openjpeg
itk::JPEG2000ImageIOFactorySupports for the JPEG2000 file format based on openjpeg
itk::JPEGImageIOImageIO object for reading and writing JPEG images
itk::JPEGImageIOFactoryCreate instances of JPEGImageIO objects using an object factory
itk::KalmanLinearEstimator< T, VEstimatorDimension >Implement a linear recursive estimator
itk::KappaSigmaThresholdImageCalculator< TInputImage, TMaskImage >Compute moments of an n-dimensional image
itk::KappaSigmaThresholdImageFilter< TInputImage, TMaskImage, TOutputImage >Threshold an image using multiple Otsu Thresholds
itk::KappaStatisticImageToImageMetric< TFixedImage, TMovingImage >Computes similarity between two binary objects to be registered
itk::Statistics::KdTree< TSample >This class provides methods for k-nearest neighbor search and related data structures for a k-d tree
itk::Statistics::KdTreeBasedKmeansEstimator< TKdTree >Fast k-means algorithm implementation using k-d tree structure
itk::Statistics::KdTreeGenerator< TSample >This class generates a KdTree object without centroid information
itk::Statistics::KdTreeNode< TSample >This class defines the interface of its derived classes
itk::Statistics::KdTreeNonterminalNode< TSample >This is a subclass of the KdTreeNode
itk::Statistics::KdTreeTerminalNode< TSample >This class is the node that doesn't have any child node. The IsTerminal method returns true for this class. This class stores the instance identifiers belonging to this node, while the nonterminal nodes do not store them. The AddInstanceIdentifier and GetInstanceIdentifier are storing and retrieving the instance identifiers belonging to this node
itk::Statistics::KdTreeWeightedCentroidNonterminalNode< TSample >This is a subclass of the KdTreeNode
itk::KernelFunctionBase< TRealValueType >Kernel used for density estimation and nonparameteric regression
itk::KernelImageFilter< TInputImage, TOutputImage, TKernel >A base class for all the filters working on an arbitrary shaped neighborhood
itk::KernelTransform< TScalarType, NDimensions >
itk::KittlerIllingworthThresholdCalculator< THistogram, TOutput >Computes the KittlerIllingworth's threshold for an image
itk::KittlerIllingworthThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the KittlerIllingworth Threshold
itk::KLMDynamicBorderArray< TBorder >Object maintaining a reference to a list of borders associated with a region
itk::KLMRegionGrowImageFilter< TInputImage, TOutputImage >Base class for a region growing object that performs energy-based region growing for multiband images
itk::KLMSegmentationBorderBase class for KLMSegmentationBorder object
itk::KLMSegmentationRegionBase class for KLMSegmentationRegion object
itk::KullbackLeiblerCompareHistogramImageToImageMetric< TFixedImage, TMovingImage >Computes the Kubler Lieblach(KL) metric between the histogram of the two images to be registered and a training histogram
itk::Functor::KurtosisLabelObjectAccessor< TLabelObject >
itk::LabelContourImageFilter< TInputImage, TOutputImage >Labels the pixels on the border of the objects in a labeled image
itk::LabelGeometryImageFilter< TLabelImage, TIntensityImage >::LabelGeometryGeometry stored per label
itk::LabelGeometryImageFilter< TLabelImage, TIntensityImage >Given a label map and an optional intensity image, compute geometric features
itk::LabelImageGaussianInterpolateImageFunction< TInputImage, TCoordRep, TPixelCompare >Interpolation function for multi-label images that implicitly smooths the binary images corresponding to each label and returns the label with largest vote
itk::LabelImageToLabelMapFilter< TInputImage, TOutputImage >Convert a labeled image to a label collection image
itk::LabelImageToShapeLabelMapFilter< TInputImage, TOutputImage >Converts a label image to a label map and valuates the shape attributes
itk::LabelImageToStatisticsLabelMapFilter< TInputImage, TFeatureImage, TOutputImage >Convenient class to convert a label image to a label map and valuate the statistics attributes at once
itk::Functor::LabelLabelObjectAccessor< TLabelObject >
itk::LabelMap< TLabelObject >Templated n-dimensional image to store labeled objects
itk::LabelMapContourOverlayImageFilter< TLabelMap, TFeatureImage, TOutputImage >Apply a colormap to the contours (outlines) of each object in a label map and superimpose it on top of the feature image
itk::LabelMapFilter< TInputImage, TOutputImage >Base class for filters that take an image as input and overwrite that image as the output
itk::LabelMapMaskImageFilter< TInputImage, TOutputImage >Mask and image with a LabelMap
itk::LabelMapOverlayImageFilter< TLabelMap, TFeatureImage, TOutputImage >Apply a colormap to a label map and superimpose it on an image
itk::LabelMapToAttributeImageFilter< TInputImage, TOutputImage, TAttributeAccessor >Convert a LabelMap to a labeled image
itk::LabelMapToBinaryImageFilter< TInputImage, TOutputImage >Convert a LabelMap to a binary image
itk::LabelMapToLabelImageFilter< TInputImage, TOutputImage >Converts a LabelMap to a labeled image
itk::LabelMapToRGBImageFilter< TInputImage, TOutputImage >Convert a LabelMap to a colored image
itk::LabelObject< TLabel, VImageDimension >The base class for the representation of an labeled binary object in an image
itk::Functor::LabelObjectComparator< TLabelObject, TAttributeAccessor >
itk::LabelObjectLine< VImageDimension >
LabelObjectLineComparatorPerforms a comparison of l1 < l2. Returns true if l1 is strictly less than l2
itk::Functor::LabelObjectLineComparator< TLabelObjectLine >
itk::Functor::LabelObjectReverseComparator< TLabelObject, TAttributeAccessor >
itk::LabelOverlapMeasuresImageFilter< TLabelImage >Computes overlap measures between the set same set of labels of pixels of two images. Background is assumed to be 0
itk::Functor::LabelOverlayFunctor< TInputPixel, TLabel, TRGBPixel >Functor for applying a colormap to a label image and combine it with a grayscale image
itk::LabelOverlayImageFilter< TInputImage, TLabelImage, TOutputImage >Apply a colormap to a label image and put it on top of the input image
itk::LabelSelectionLabelMapFilter< TImage >Remove the objects according to the value of their attribute
itk::LabelOverlapMeasuresImageFilter< TLabelImage >::LabelSetMeasuresMetrics stored per label
itk::LabelShapeKeepNObjectsImageFilter< TInputImage >Keep N objects according to their shape attributes
itk::LabelShapeOpeningImageFilter< TInputImage >Remove the objects according to the value of their shape attribute
itk::LabelStatisticsImageFilter< TInputImage, TLabelImage >::LabelStatisticsStatistics stored per label
itk::LabelStatisticsImageFilter< TInputImage, TLabelImage >Given an intensity image and a label map, compute min, max, variance and mean of the pixels associated with each label or segment
itk::LabelStatisticsKeepNObjectsImageFilter< TInputImage, TFeatureImage >Keep N objects according to their statistics attributes
itk::LabelStatisticsOpeningImageFilter< TInputImage, TFeatureImage >Remove the objects according to the value of their statistics attribute
itk::Functor::LabelToRGBFunctor< TLabel, TRGBPixel >Functor for converting labels into RGB triplets
itk::LabelToRGBImageFilter< TLabelImage, TOutputImage >Apply a colormap to a label image
itk::LabelUniqueLabelMapFilter< TImage >Make sure that the objects are not overlapping
itk::LabelVotingImageFilter< TInputImage, TOutputImage >This filter performs pixelwise voting among an arbitrary number of input images, where each of them represents a segmentation of the same scene (i.e., image)
itk::Function::LanczosWindowFunction< VRadius, TInput, TOutput >Window function for sinc interpolation.

\[ w(x) = \textrm{sinc} ( \frac{x}{m} ) \]

Note: Paper referenced in WindowedSincInterpolateImageFunction gives an incorrect definition of this window function

itk::LandmarkBasedTransformInitializer< TTransform, TFixedImage, TMovingImage >LandmarkBasedTransformInitializer is a helper class intended to The class computes the transform that aligns the fixed and moving images given a set of landmarks. The class is templated over the Transform type. The transform computed gives the best fit transform that maps the fixed and moving images in a least squares sense. The indices are taken to correspond, so point 1 in the first set will get mapped close to point 1 in the second set, etc. An equal number of fixed and moving landmarks need to be specified using SetFixedLandmarks() SetMovingLandmarks(). Any number of landmarks may be specified. Call InitializeTransform() to initialize the transform
itk::LandmarkDisplacementFieldSource< TOutputImage >Computes a displacement field from two sets of landmarks
itk::LandmarkSpatialObject< TDimension >Representation of a Landmark based on the spatial object classes
itk::LandweberDeconvolutionImageFilter< TInputImage, TKernelImage, TOutputImage >Deconvolve an image using the Landweber deconvolution algorithm
itk::Functor::LandweberMethod< TInput1, TInput2, TInput3, TOutput >Functor class for computing a Landweber iteration
itk::LaplacianImageFilter< TInputImage, TOutputImage >
itk::LaplacianOperator< TPixel, VDimension, TAllocator >A NeighborhoodOperator for use in calculating the Laplacian at a pixel
itk::LaplacianRecursiveGaussianImageFilter< TInputImage, TOutputImage >Computes the Laplacian of Gaussian (LoG) of an image
itk::LaplacianSegmentationLevelSetFunction< TImageType, TFeatureImageType >This function is used in LaplacianSegmentationImageFilter to segment structures in an image based Laplacian edges
itk::LaplacianSegmentationLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on a second derivative image features
itk::LaplacianSharpeningImageFilter< TInputImage, TOutputImage >This filter sharpens an image using a Laplacian. LaplacianSharpening highlights regions of rapid intensity change and therefore highlights or enhances the edges. The result is an image that appears more in focus
itk::Statistics::LayerBase< TMeasurementVector, TTargetVector >This is the itkLayerBase class
itk::LBFGSBOptimizerLimited memory Broyden Fletcher Goldfarb Shannon minimization with simple bounds
LBFGSBOptimizerHelperWrapper helper around vnl_lbfgsb
itk::LBFGSOptimizerWrap of the vnl_lbfgs algorithm
itk::LeafTreeIterator< TTreeType >
itk::Statistics::LearningFunctionBase< LayerType, TTargetVector >The LearningFunctionBase is the base class for all the learning strategies
itk::Concept::LessThanComparable< T1, T2 >
itk::LevelOrderTreeIterator< TTreeType >Iterate over a tree in level order
itk::LevelSetBase< TInput, VDimension, TOutput, TDomain >Abstract base class for the representation of a level-set function
itk::LevelSetContainer< TIdentifier, TLevelSet >Container of Level-Sets
itk::LevelSetContainer< TIdentifier, LevelSetDenseImageBase< TImage > >Container class for dense level sets
itk::LevelSetContainerBase< TIdentifier, TLevelSet >Container of level set
itk::LevelSetBase< TInput, VDimension, TOutput, TDomain >::LevelSetDataTypeConvenient data structure to cache computed characteristics
itk::LevelSetDenseImageBase< TImage >Base class for the "dense" representation of a level-set function on one image
itk::LevelSetDomainMapImageFilter< TInputImage, TOutputImage >::LevelSetDomainSpecifies an image region where an unique std::list of level sets Id's are defined
itk::LevelSetDomainMapImageFilter< TInputImage, TOutputImage >
itk::LevelSetDomainPartition< TImage >Helper class used to share data in the ScalarChanAndVeseLevelSetFunction
itk::LevelSetDomainPartitionBase< TDomain >Helper class used to partition domain and efficiently compute overlap
itk::LevelSetDomainPartitionImageBase< TImage >Helper class used to partition domain and efficiently compute overlap
itk::LevelSetDomainPartitionImageWithKdTree< TImage >Helper class used to share data in the ScalarChanAndVeseLevelSetFunction
itk::LevelSetDomainPartitionMeshBase< TMesh >Helper class used to partition domain and efficiently compute overlap
itk::LevelSetEquationAdvectionTerm< TInput, TLevelSetContainer >Derived class to represents an advection term in the level-set evolution PDE
itk::LevelSetEquationChanAndVeseExternalTerm< TInput, TLevelSetContainer >Class to represent the external energy Chan And Vese term
itk::LevelSetEquationChanAndVeseInternalTerm< TInput, TLevelSetContainer >Class to represent the internal energy Chan And Vese term
itk::LevelSetEquationContainerBase< TTermContainer >Class for holding a set of level set equations (PDEs)
itk::LevelSetEquationCurvatureTerm< TInput, TLevelSetContainer >Derived class to represents a curvature term in the level-set evolution PDE
itk::LevelSetEquationLaplacianTerm< TInput, TLevelSetContainer >Derived class to represents a propagation term in the level-set evolution PDE
itk::LevelSetEquationPropagationTerm< TInput, TLevelSetContainer, TPropagationImage >Derived class to represents a propagation term in the level-set evolution PDE
itk::LevelSetEquationRegionTermBase< TInput, TLevelSetContainer >
itk::LevelSetEquationTermBase< TInputImage, TLevelSetContainer >Abstract class to represents a term in the level-set evolution PDE
itk::LevelSetEquationTermContainerBase< TInputImage, TLevelSetContainer >Class for container holding the terms of a given level set update equation
itk::LevelSetEvolution< TEquationContainer, TLevelSet >Class for iterating and evolving the level-set function
itk::LevelSetEvolution< TEquationContainer, LevelSetDenseImageBase< TImage > >
itk::LevelSetEvolution< TEquationContainer, MalcolmSparseLevelSetImage< VDimension > >
itk::LevelSetEvolution< TEquationContainer, ShiSparseLevelSetImage< VDimension > >
itk::LevelSetEvolution< TEquationContainer, WhitakerSparseLevelSetImage< TOutput, VDimension > >
itk::LevelSetEvolutionBase< TEquationContainer, TLevelSet >Class for iterating and evolving the dense level-set function
itk::LevelSetEvolutionComputeIterationThreader< TLevelSet, TDomainPartitioner, TLevelSetEvolution >Thread the ComputeIteration method
itk::LevelSetEvolutionComputeIterationThreader< LevelSetDenseImageBase< TImage >, ThreadedImageRegionPartitioner< TImage::ImageDimension >, TLevelSetEvolution >
itk::LevelSetEvolutionComputeIterationThreader< LevelSetDenseImageBase< TImage >, ThreadedIteratorRangePartitioner< typename TLevelSetEvolution::DomainMapImageFilterType::DomainMapType::const_iterator >, TLevelSetEvolution >
itk::LevelSetEvolutionComputeIterationThreader< WhitakerSparseLevelSetImage< TOutput, VDimension >, ThreadedIteratorRangePartitioner< typename WhitakerSparseLevelSetImage< TOutput, VDimension >::LayerConstIterator >, TLevelSetEvolution >
itk::LevelSetEvolutionNumberOfIterationsStoppingCriterion< TLevelSetContainer >
itk::LevelSetEvolutionStoppingCriterionBase< TLevelSetContainer >
itk::LevelSetEvolutionUpdateLevelSetsThreader< TLevelSet, TDomainPartitioner, TLevelSetEvolution >Threade the UpdateLevelSets method
itk::LevelSetEvolutionUpdateLevelSetsThreader< LevelSetDenseImageBase< TImage >, ThreadedImageRegionPartitioner< TImage::ImageDimension >, TLevelSetEvolution >
itk::LevelSetFunction< TImageType >The LevelSetFunction class is a generic function object which can be used to create a level set method filter when combined with an appropriate finite difference image filter. (See FiniteDifferenceImageFilter.)
itk::LevelSetFunctionWithRefitTerm< TImageType, TSparseImageType >This class extends the LevelSetFunction class by adding a grow term based on a target curvature stored in a sparse image
itk::LevelSetImageBase< TInput, VDimension, TOutput >Abstract class for a level-set function on one Image
itk::LevelSetMotionRegistrationFilter< TFixedImage, TMovingImage, TDisplacementField >Deformably register two images using level set motion
itk::LevelSetMotionRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >
itk::LevelSetNeighborhoodExtractor< TLevelSet >Locate pixels of a particular level set
itk::LevelSetNode< TPixel, VSetDimension >Represent a node in a level set
itk::LevelSetQuadEdgeMeshBase< TMesh >Base class for the surface mesh representation of a level-set function
itk::LevelSetSparseImageBase< TOutput, VDimension >Base class for the sparse representation of a level-set function on one Image
itk::LevelSetTypeDefault< TLevelSet >Level set type information
itk::LevelSetVelocityNeighborhoodExtractor< TLevelSet, TAuxValue, VAuxDimension >Locate pixels of a particular level set
itk::LevenbergMarquardtOptimizerWrap of the vnl_levenberg_marquardt algorithm
itk::LightObjectLight weight base class for most itk classes
itk::LightProcessObjectLightProcessObject is the base class for all process objects (source, filters, mappers) in the Insight data processing pipeline
itk::LinearInterpolateImageFunction< TInputImage, TCoordRep >Linearly interpolate an image at specified positions
itk::fem::LinearSystemWrapperDefines all functions required by Solver class to allocate, assemble and solve a linear system of equation
itk::fem::LinearSystemWrapperDenseVNLLinearSystemWrapper class that uses VNL numeric library functions to define a sparse linear system of equations
itk::fem::LinearSystemWrapperItpackLinearSystemWrapper class that uses Itpack numeric library functions to define and solve a sparse linear system of equations
itk::fem::LinearSystemWrapperVNLLinearSystemWrapper class that uses VNL numeric library functions to define a sparse linear system of equations
itk::LineCell< TCellInterface >Represents a line segment for a Mesh
itk::LineConstIterator< TImage >An iterator that walks a Bresenham line through an ND image with read-only access to pixels
itk::LineIterator< TImage >An iterator that walks a Bresenham line through an ND image with write access to pixels
itk::AttributeUniqueLabelMapFilter< TImage, TAttributeAccessor >::LineOfLabelObject
itk::ShapeUniqueLabelMapFilter< TImage >::LineOfLabelObject
itk::AttributeUniqueLabelMapFilter< TImage, TAttributeAccessor >::LineOfLabelObjectComparator
itk::ShapeUniqueLabelMapFilter< TImage >::LineOfLabelObjectComparator
itk::LineSpatialObject< TDimension >Representation of a Line based on the spatial object classes
itk::LineSpatialObjectPoint< TPointDimension >Point used for a line definition
itk::NeuralNetworkFileReader< TNetwork >::LineType
itk::ListNode< TValueType >
itk::Statistics::ListSample< TMeasurementVector >This class is the native implementation of the a Sample with an STL container
itk::LiThresholdCalculator< THistogram, TOutput >Computes the Li threshold for an image. Aka intermeans
itk::LiThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the Li Threshold
itk::fem::LoadGeneral abstract load base class
itk::fem::LoadBCGeneric essential (Dirichlet) boundary conditions
itk::fem::LoadBCMFCGeneric linear multi freedom displacement constraint in global coordinate system
itk::fem::LoadEdgeA generic load that can be applied to an edge of the element
itk::fem::LoadElementVirtual element load base class
itk::fem::LoadGravAbstract gravity load class
itk::fem::LoadGravConstConstant gravity load class
itk::fem::LoadLandmarkThis load is derived from the motion of a specific landmark
itk::fem::LoadNodeThis load is applied on a specific point within the system
itk::fem::LoadPointThis load is applied on a point in an element
itk::fem::LoadTest< TClass >Example to show how to define templated load classes
itk::Functor::Log< TInput, TOutput >
itk::Functor::Log10< TInput, TOutput >
itk::Log10ImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_log10() of its pixels
itk::Log10ImageFilter< TInputImage, TOutputImage >Computes the log10 of each pixel
itk::Accessor::Log10PixelAccessor< TInternalType, TExternalType >Give access to the vcl_log10() function of a value
itk::LoggerUsed for logging information during a run
itk::LoggerBaseUsed for logging information during a run
itk::LoggerManagerUsed for centrally managing loggers
itk::LoggerOutputUsed for overriding itk::OutputWindow to redirect messages to itk::Logger
itk::LoggerThreadWrapper< SimpleLoggerType >Used for providing logging service as a separate thread
itk::Concept::LogicalOperators< T1, T2, T3 >
itk::LogImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_log() of its pixels
itk::LogImageFilter< TInputImage, TOutputImage >Computes the log() of each pixel
itk::LogOutputRepresents an output stream
itk::Accessor::LogPixelAccessor< TInternalType, TExternalType >Give access to the vcl_log() function of a value
itk::Statistics::LogSigmoidTransferFunction< ScalarType >This is the itkLogSigmoidTransferFunction class
itk::LSMImageIOImageIO class for reading LSM (Zeiss) images LSM is a line of confocal laser scanning microscopes produced by the Zeiss company LSM files are essentially extensions of the TIFF multiple image stack file format
itk::LSMImageIOFactoryCreate instances of LSMImageIO objects using an object factory
itk::Functor::MagnitudeAndPhaseToComplex< TInput1, TInput2, TOutput >
itk::MagnitudeAndPhaseToComplexImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements pixel-wise conversion of magnitude and phase data into complex voxels
itk::Statistics::MahalanobisDistanceMembershipFunction< TVector >MahalanobisDistanceMembershipFunction models class membership using Mahalanobis distance
itk::Statistics::MahalanobisDistanceMetric< TVector >MahalanobisDistanceMetric class computes a Mahalanobis distance given a mean and covariance
itk::MahalanobisDistanceThresholdImageFunction< TInputImage, TCoordRep >Returns true if the pixel value of a vector image has a Mahalanobis distance below the value specified by the threshold
itk::Functor::MakeJoin< TImage1, TImage2 >
itk::MalcolmSparseLevelSetImage< VDimension >Derived class for the shi representation of level-set function
MallinfoMemoryUsageObserver
MallinfoMemoryUsageObserver
itk::Statistics::ManhattanDistanceMetric< TVector >Euclidean distance function
itk::ManifoldParzenWindowsPointSetFunction< TPointSet, TOutput, TCoordRep >Point set function based on n-dimensional parzen windowing
itk::ManualWisdomFilenameGenerator
itk::MeshIOBase::MapComponentType< T >
itk::MapContainer< TElementIdentifier, TElement >A wrapper of the STL "map" container
itk::MapDataBase class for map data containers
itk::MapFileParser< TMapData >TODO
itk::ImageIOBase::MapPixelType< TPixel >
itk::MapRecordMapRecord class
itk::MaskedFFTNormalizedCorrelationImageFilter< TInputImage, TOutputImage >Calculate masked normalized cross correlation using FFTs
itk::Statistics::MaskedImageToHistogramFilter< TImage, TMaskImage >This class generates an histogram from an image
itk::MaskedMovingHistogramImageFilter< TInputImage, TMaskImage, TOutputImage, TKernel, THistogram >
itk::MaskedRankImageFilter< TInputImage, TMaskImage, TOutputImage, TKernel >Rank filter of a greyscale image
MaskFeaturePointSelectionFilterGenerate a PointSet containing the feature points selected from a masked 3D input image
itk::MaskFeaturePointSelectionFilter< Image< TImagePixel, VImageDimension >, Image< TMaskPixel, VImageDimension >, PointSet< Matrix< TTensorValueType, VImageDimension, VImageDimension >, VImageDimension, TFeaturesTraits > >
itk::MaskImageFilter< TInputImage, TMaskImage, TOutputImage >Mask an image with a mask. image with the mask
itk::Functor::MaskInput< TInput, TMask, TOutput >
itk::MaskNegatedImageFilter< TInputImage, TMaskImage, TOutputImage >Mask an image with the negative of a mask
itk::Functor::MaskNegatedInput< TInput, TMask, TOutput >
itk::MaskNeighborhoodOperatorImageFilter< TInputImage, TMaskImage, TOutputImage, TOperatorValueType >Applies a single NeighborhoodOperator to an image, processing only those pixels that are under a mask
itk::MatchCardinalityImageToImageMetric< TFixedImage, TMovingImage >Computes similarity between two objects to be registered
itk::fem::MaterialBase class for storing all the implicit material and other properties required to fully define the element class
itk::fem::MaterialLinearElasticityLinear elasticity material class
itk::MatlabTransformIOCreate instances of MatlabTransformIO objects
itk::MatlabTransformIOFactoryCreate instances of MatlabTransformIO objects using an object factory
itk::Matrix< T, NRows, NColumns >A templated class holding a M x N size Matrix
itk::MatrixCoefficients< TInputMesh >Superclass for all the matrix coefficients computation classes
itk::Functor::MatrixIndexSelection< TInput, TOutput >
itk::MatrixIndexSelectionImageFilter< TInputImage, TOutputImage >Extracts the selected indices of a matrix image that is the input pixel type
itk::MatrixOffsetTransformBase< TScalarType, NInputDimensions, NOutputDimensions >Matrix and Offset transformation of a vector space (e.g. space coordinates)
itk::MatrixResizeableDataObject< TItemType >Allows a VNL matrix to be a DataObject with the flexibility of being resizable
itk::MattesMutualInformationImageToImageMetric< TFixedImage, TMovingImage >Computes the mutual information between two images to be registered using the method of Mattes et al
itk::MattesMutualInformationImageToImageMetricv4< TFixedImage, TMovingImage, TVirtualImage >Computes the mutual information between two images to be registered using the method of Mattes et al
itk::MattesMutualInformationImageToImageMetricv4GetValueAndDerivativeThreader< TDomainPartitioner, TImageToImageMetric, TMattesMutualInformationMetric >Processes points for MattesMutualInformationImageToImageMetricv4 GetValueAndDerivative
itk::MaxFunctor< TPixel >
itk::Functor::Maximum< TInput1, TInput2, TOutput >
itk::Functor::Maximum1< TInput, TOutput >
itk::Functor::MaximumAccumulator< TInputPixel >
itk::Statistics::MaximumDecisionRuleA decision rule that returns the class label with the largest discriminant score
itk::MaximumEntropyThresholdCalculator< THistogram, TOutput >Computes the MaximumEntropy's threshold for an image
itk::MaximumEntropyThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the MaximumEntropy Threshold
itk::MaximumImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements a pixel-wise operator Max(a,b) between two images
itk::Functor::MaximumIndexLabelObjectAccessor< TLabelObject >
itk::Functor::MaximumLabelObjectAccessor< TLabelObject >
itk::MaximumProjectionImageFilter< TInputImage, TOutputImage >Maximum projection
itk::Statistics::MaximumRatioDecisionRuleA decision rule that operates as a frequentist's approximation to Bayes rule
itk::MaxMeasureBoundCriterion< TMesh, TElement, TMeasure, TPriorityQueueWrapper >
itk::MaxPriorityQueueElementWrapper< TElement, TElementPriority, TElementIdentifier >
itk::Functor::MeanAccumulator< TInputPixel, TAccumulate >
itk::MeanImageFilter< TInputImage, TOutputImage >Applies an averaging filter to an image
itk::MeanImageFunction< TInputImage, TCoordRep >Calculate the mean value in the neighborhood of a pixel
itk::Functor::MeanLabelObjectAccessor< TLabelObject >
itk::MeanProjectionImageFilter< TInputImage, TOutputImage, TAccumulate >Mean projection
itk::MeanReciprocalSquareDifferenceImageToImageMetric< TFixedImage, TMovingImage >Computes similarity between two objects to be registered
itk::MeanReciprocalSquareDifferencePointSetToImageMetric< TFixedPointSet, TMovingImage >Computes similarity between pixel values of a point set and intensity values in an image
itk::Statistics::MeanSampleFilter< TSample >Given a sample, this filter computes the sample mean
itk::Statistics::MeanSquaredErrorFunction< TMeasurementVector, ScalarType >
MeanSquaredErrorFunction_This is the itkMeanSquaredErrorFunction_ class
itk::MeanSquareRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >
itk::MeanSquaresHistogramImageToImageMetric< TFixedImage, TMovingImage >Computes mean squared difference similarity measure between two images to be registered
itk::MeanSquaresImageToImageMetric< TFixedImage, TMovingImage >TODO
itk::MeanSquaresImageToImageMetricv4< TFixedImage, TMovingImage, TVirtualImage >Class implementing a mean squares metric
itk::MeanSquaresImageToImageMetricv4GetValueAndDerivativeThreader< TDomainPartitioner, TImageToImageMetric, TMeanSquaresMetric >Processes points for MeanSquaresImageToImageMetricv4 GetValueAndDerivative
itk::MeanSquaresPointSetToImageMetric< TFixedPointSet, TMovingImage >Computes similarity between pixel values of a point set and intensity values of an image
itk::Statistics::MeasurementVectorPixelTraits< TPixelType >
itk::Statistics::MeasurementVectorTraits
itk::Statistics::MeasurementVectorTraitsTypes< TMeasurementVector >
itk::Statistics::MeasurementVectorTraitsTypes< std::vector< T > >
itk::Functor::MedianAccumulator< TInputPixel >
itk::MedianImageFilter< TInputImage, TOutputImage >Applies a median filter to an image
itk::MedianImageFunction< TInputImage, TCoordRep >Calculate the median value in the neighborhood of a pixel
itk::Functor::MedianLabelObjectAccessor< TLabelObject >
itk::MedianProjectionImageFilter< TInputImage, TOutputImage >Median projection
itk::MemberCommand< T >A Command subclass that calls a pointer to a member function
itk::Statistics::MembershipFunctionBase< TVector >MembershipFunctionBase defines common interfaces for membership functions
itk::Statistics::MembershipSample< TSample >Container for storing the instance-identifiers of other sample with their associated class labels
itk::MemoryAllocationError
itk::ObjectStore< TObjectType >::MemoryBlock
itk::MemoryProbeComputes the memory allocated between two points in code
itk::MemoryProbesCollectorBaseAggregates a set of memory probes
MemoryUsageObserverProvides the memory usage of the process
MemoryUsageObserver
itk::MemoryUsageObserverBase
itk::watershed::SegmentTree< TScalarType >::merge_comp
itk::watershed::SegmentTree< TScalarType >::merge_t
itk::MergeLabelMapFilter< TImage >Merges several Label Maps
itk::Statistics::MersenneTwisterRandomVariateGeneratorMersenneTwisterRandom random variate generator
itk::Mesh< TPixelType, VDimension, TMeshTraits >Implements the N-dimensional mesh structure
itk::MeshConvertPixelTraits< PixelType >Traits class used to by ConvertPixels to convert blocks of pixels
itk::MeshFileReader< TOutputMesh, ConvertPointPixelTraits, ConvertCellPixelTraits >Mesh source that reads mesh data from a single file
itk::MeshFileReaderExceptionBase exception class for IO conflicts
itk::MeshFileWriter< TInputMesh >Writes mesh data to a single file
itk::MeshFileWriterExceptionBase exception class for IO problems during writing
MeshFunctionBaseBase class for mesh function object modifiers
itk::MeshIOBaseAbstract superclass defines mesh IO interface
itk::MeshIOFactoryCreate instances of MeshIO objects using an object factory
itk::MeshRegionA mesh region represents an unstructured region of data
itk::MeshSource< TOutputMesh >Base class for all process objects that output mesh data
itk::MeshSpatialObject< TMesh >Implementation of an Mesh as spatial object
itk::MeshToMeshFilter< TInputMesh, TOutputMesh >MeshToMeshFilter is the base class for all process objects that output mesh data, and require mesh data as input. Specifically, this class defines the SetInput() method for defining the input to a filter
itk::MetaArrayReader
itk::MetaArrayWriter
itk::MetaArrowConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaBlobConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaContourConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaConverterBase< VDimension >Base class for MetaObject<->SpatialObject converters
itk::MetaDataDictionaryProvides a mechanism for storing a collection of arbitrary data types
itk::MetaDataDictionary::MetaDataDictionaryMapType
itk::MetaDataObject< MetaDataObjectType >Allows arbitrary data types to be stored as MetaDataObjectBase types, and to be stored in a MetaDataDictionary
itk::MetaDataObjectBaseThe common interface for MetaDataObject's
itk::MetaDTITubeConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaEllipseConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaEventEvent abstract class
itk::MetaFEMObjectConverter< NDimensions >Converts from a FEMObject into a FEMSpatialOPbject
itk::MetaGaussianConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaGroupConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaImageConverter< NDimensions, TPixel, TSpatialObjectType >Converts between MetaObject<->SpatialObject
itk::MetaImageIORead MetaImage file format
itk::MetaImageIOFactoryCreate instances of MetaImageIO objects using an object factory
itk::MetaImageMaskConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaLandmarkConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaLineConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaMeshConverter< NDimensions, PixelType, TMeshTraits >Converts between MetaObject<->SpatialObject
itk::MetaSceneConverter< NDimensions, PixelType, TMeshTraits >Converts between MetaObject and SpaitalObject scenes
itk::MetaSurfaceConverter< NDimensions >Converts between MetaObject<->SpatialObject
itk::MetaTubeConverter< NDimensions >Converts between MetaObject<->SpatialObject
MetaVesselTubeConverterConverts between MetaObject<->SpatialObject
itk::MetaVesselTubeConverter< NDimensions >This is the MetaVesselTubeConverter class
itk::fem::LoadBCMFC::MFCTermClass that holds information about one term in MFC constraint equation
itk::MINC2ImageIOClass that defines how to read MINC2 file format. Note,like ITK, MINC2 is N dimensional and dimensions can be submitted in any arbitrary order. Here we make sure the dimensions are ordered as xspace, yspace, zspace, time and vector_dimension and so on or xfrequencey, yfrequency, zfrequency, tfrequency and vector_dimension and so on NOTE** This class only reads the regularly sampled dimensions as I am not sure how to deal with "iregularly sampled" dimensions yet!
itk::MINC2ImageIOFactoryCreate instances of MINC2ImageIO objects using an object factory
itk::MinFunctor< TPixel >
itk::Functor::Minimum< TInput1, TInput2, TOutput >
itk::Functor::MinimumAccumulator< TInputPixel >
itk::Statistics::MinimumDecisionRuleA decision rule that returns the class label with the smallest discriminant score
itk::MinimumImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements a pixel-wise operator Min(a,b) between two images
itk::Functor::MinimumIndexLabelObjectAccessor< TLabelObject >
itk::Functor::MinimumLabelObjectAccessor< TLabelObject >
itk::MinimumMaximumImageCalculator< TInputImage >Computes the minimum and the maximum intensity values of an image
itk::MinimumMaximumImageFilter< TInputImage >Computes the minimum and the maximum intensity values of an image
itk::MinimumProjectionImageFilter< TInputImage, TOutputImage >Minimum projection
itk::MiniPipelineSeparableImageFilter< TInputImage, TOutputImage, TFilter >A separable filter for filter which are using radius
itk::MinMaxCurvatureFlowFunction< TImage >
itk::MinMaxCurvatureFlowImageFilter< TInputImage, TOutputImage >Denoise an image using min/max curvature flow
itk::MinMeasureBoundCriterion< TMesh, TElement, TMeasure, TPriorityQueueWrapper >
itk::MinPriorityQueueElementWrapper< TElement, TElementPriority, TElementIdentifier >
itk::MIRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >
itk::MirrorPadImageFilter< TInputImage, TOutputImage >Increase the image size by padding with replicants of the input image value
itk::Statistics::MixtureModelComponentBase< TSample >Base class for distribution modules that supports analytical way to update the distribution parameters
itk::ModifiedEvent
itk::Functor::Modulus2< TInput1, TInput2, TOutput >
itk::Functor::Modulus3< TInput1, TInput2, TInput3, TOutput >
itk::ModulusImageFilter< TInputImage, TOutputImage >Computes the modulus (x % dividend) pixel-wise
itk::Functor::ModulusSquare3< TInput1, TInput2, TInput3, TOutput >
itk::Functor::ModulusTransform< TInput, TOutput >
itk::MomentsThresholdCalculator< THistogram, TOutput >Computes the Moments's threshold for an image
itk::MomentsThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the Moments Threshold
itk::Function::MorphologicalGradientHistogram< TInputPixel >
itk::MorphologicalGradientImageFilter< TInputImage, TOutputImage, TKernel >Gray scale dilation of an image
itk::MorphologicalWatershedFromMarkersImageFilter< TInputImage, TLabelImage >Morphological watershed transform from markers
itk::MorphologicalWatershedImageFilter< TInputImage, TOutputImage >TODO
itk::Function::MorphologyHistogram< TInputPixel, TCompare >
itk::MorphologyImageFilter< TInputImage, TOutputImage, TKernel >Base class for the morphological operations such as erosion and dialation
itk::MovingHistogramDilateImageFilter< TInputImage, TOutputImage, TKernel >Gray scale dilation of an image
itk::MovingHistogramErodeImageFilter< TInputImage, TOutputImage, TKernel >Gray scale erosion of an image
itk::MovingHistogramImageFilter< TInputImage, TOutputImage, TKernel, THistogram >Implements a generic moving histogram algorithm
itk::MovingHistogramImageFilterBase< TInputImage, TOutputImage, TKernel >Implements a generic moving histogram algorithm
itk::MovingHistogramMorphologicalGradientImageFilter< TInputImage, TOutputImage, TKernel >Morphological gradients enhance the variation of pixel intensity in a given neighborhood
itk::MovingHistogramMorphologyImageFilter< TInputImage, TOutputImage, TKernel, THistogram >Base class for MovingHistogramDilateImageFilter and MovingHistogramErodeImageFilter
itk::MRASlabIdentifier< TInputImage >Identifies slab in MR images comparing minimum intensity averages
itk::MRCHeaderObjectThis class is a light wrapper for a couple of plain old data structures, so that they can be utilized in a MetaDataDictionary
itk::MRCImageIOAn ImageIO class to read the MRC file format. The MRC file format frequently has the extension ".mrc" or ".rec". It is used frequently for electron microscopy and is an emerging standard for cryo-electron tomography and molecular imaging. The format is used to represent 2D, 3D images along with 2D tilt series for tomography
itk::MRCImageIOFactoryCreate instances of MRCImageIO objects using an object factory
itk::MRFImageFilter< TInputImage, TClassifiedImage >Implementation of a labeller object that uses Markov Random Fields to classify pixels in an image data set
itk::MRIBiasEnergyFunction< TImage, TImageMask, TBiasField >Cost function for optimization
itk::MRIBiasFieldCorrectionFilter< TInputImage, TOutputImage, TMaskImage >Corrects 3D MRI bias field
itk::Functor::Mult< TInput1, TInput2, TOutput >
itk::MultiGradientOptimizerv4Multiple gradient-based optimizers are combined in order to perform a multi-objective optimization
itk::Statistics::MultilayerNeuralNetworkBase< TMeasurementVector, TTargetVector, TLearningLayer >This is the itkMultilayerNeuralNetworkBase class
itk::MultiphaseDenseFiniteDifferenceImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, TIdCell >
itk::MultiphaseFiniteDifferenceImageFilter< TInputImage, TFeatureImage, TOutputImage, TFiniteDifferenceFunction, TIdCell >
itk::MultiphaseSparseFiniteDifferenceImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, TIdCell >This class implements a finite difference partial differential equation solver for evolving surfaces embedded in volumes as level-sets
itk::MultipleLogOutputAllows writing simultaneously to multiple streams. Note that the class derives from std::streambuf and contains a std::set<> of LogOutput
itk::MultipleValuedCostFunctionThis class is a base for the CostFunctions returning a multiple values
itk::MultipleValuedNonLinearOptimizerThis class is a base for the Optimization methods that optimize a multiple valued function
itk::MultipleValuedNonLinearVnlOptimizerThis class is a base for the Optimization methods that optimize a multi-valued function
itk::MultipleValuedVnlCostFunctionAdaptorThis class is an Adaptor that allows to pass itk::MultipleValuedCostFunctions to vnl_optimizers expecting a vnl_cost_function
itk::Concept::MultiplyAndAssignOperator< T1, T2 >
itk::MultiplyByConstantImageFilter< TInputImage, TConstant, TOutputImage >Multiply all input pixels by a constant
itk::MultiplyImageFilter< TInputImage1, TInputImage2, TOutputImage >Pixel-wise multiplication of two images
itk::Concept::MultiplyOperator< T1, T2, T3 >
itk::Statistics::MultiquadricRadialBasisFunction< ScalarType >This is the itkMultiquadricRadialBasisFunction class
itk::MultiResolutionImageRegistrationMethod< TFixedImage, TMovingImage >Base class for multi-resolution image registration methods
itk::MultiResolutionPDEDeformableRegistration< TFixedImage, TMovingImage, TDisplacementField, TRealType >Framework for performing multi-resolution PDE deformable registration
itk::MultiResolutionPyramidImageFilter< TInputImage, TOutputImage >Framework for creating images in a multi-resolution pyramid
itk::MultiScaleHessianBasedMeasureImageFilter< TInputImage, THessianImage, TOutputImage >A filter to enhance structures using Hessian eigensystem-based measures in a multiscale framework
itk::MultiStartOptimizerv4Multi-start searches over input parameters and returns the best metric value
itk::ImageToImageMetric< TFixedImage, TMovingImage >::MultiThreaderParameterType
itk::MultivariateLegendrePolynomial2D and 3D multivariate Legendre Polynomial
itk::CellInterface< TPixelType, TCellTraits >::MultiVisitorA visitor that can visit different cell types in a mesh. CellInterfaceVisitor instances can be registered for each type of cell that needs to be visited
itk::MutexLockMutual exclusion locking class
itk::MutexLockHolder< TMutex >A container to store a Mutex
itk::MutualInformationHistogramImageToImageMetric< TFixedImage, TMovingImage >Computes the mutual information between two images to be registered using the histograms of the intensities in the images. This class is templated over the type of the fixed and moving images to be compared
itk::MutualInformationImageToImageMetric< TFixedImage, TMovingImage >Computes the mutual information between two images to be registered
itk::N4BiasFieldCorrectionImageFilter< TInputImage, TMaskImage, TOutputImage >Implementation of the N4 bias field correction algorithm
itk::ProcessObject::NameComparator
itk::NarrowBand< NodeType >Narrow Band class
itk::NarrowBandCurvesLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on user supplied edge potential map
itk::NarrowBandImageFilterBase< TInputImage, TOutputImage >This class implements a multi-threaded finite difference image to image solver that can be applied to an arbitrary list of pixels
itk::NarrowBandImageFilterBase< TInputImage, TOutputImage >::NarrowBandImageFilterBaseThreadStruct
itk::NarrowBandLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType, TOutputImage >A base class which defines the API for implementing a special class of image segmentation filters using level set methods
itk::NarrowBandThresholdSegmentationLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on intensity values
itk::NaryAddImageFilter< TInputImage, TOutputImage >Pixel-wise addition of N images
itk::NaryFunctorImageFilter< TInputImage, TOutputImage, TFunction >Perform a generic pixel-wise operation on N images
itk::NaryMaximumImageFilter< TInputImage, TOutputImage >Computes the pixel-wise maximum of several images
itk::NCCRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >
itk::NearestNeighborExtrapolateImageFunction< TInputImage, TCoordRep >Nearest neighbor extrapolation of a scalar image
itk::NearestNeighborInterpolateImageFunction< TInputImage, TCoordRep >Nearest neighbor interpolation of a scalar image
itk::Statistics::KdTree< TSample >::NearestNeighborsData structure for storing k-nearest neighbor search result (k number of Neighbors)
itk::Neighborhood< TPixel, VDimension, TAllocator >A light-weight container object for storing an N-dimensional neighborhood of values
itk::NeighborhoodAccessorFunctor< TImage >Provides accessor interfaces to Get pixels and is meant to be used on pointers contained within Neighborhoods. A typical user should not need to use this class directly. This class is used by the neighborhood iterators to get pixels from pixel pointers or assign a pixel to an address
itk::NeighborhoodAllocator< TPixel >A memory allocator for use as the default allocator type in Neighborhood
itk::NeighborhoodBinaryThresholdImageFunction< TInputImage, TCoordRep >Determine whether all the pixels in the specified neighborhood meet a threshold criteria
itk::NeighborhoodConnectedImageFilter< TInputImage, TOutputImage >Label pixels that are connected to a seed and lie within a neighborhood
itk::NeighborhoodInnerProduct< TImage, TOperator, TComputation >Defines the inner product operation between an Neighborhood and a NeighborhoodOperator
itk::NeighborhoodIterator< TImage, TBoundaryCondition >Defines iteration of a local N-dimensional neighborhood of pixels across an itk::Image
itk::NeighborhoodOperator< TPixel, VDimension, TAllocator >Virtual class that defines a common interface to all neighborhood operator subtypes
itk::NeighborhoodOperatorImageFilter< TInputImage, TOutputImage, TOperatorValueType >Applies a single NeighborhoodOperator to an image region
itk::NeighborhoodOperatorImageFunction< TInputImage, TOutput >Compute the convolution of a neighborhood operator with the image at a specific location in space, i.e. point, index or continuous index. This class is templated over the input image type
itk::Statistics::NeighborhoodSampler< TSample >Generates a Subsample out of a Sample, based on a user-provided distance to a MeasurementVector
itk::NeuralNetworkFileReader< TNetwork >Reader for Neural Network
itk::NeuralNetworkFileWriter< TNetwork >Writer for Neural Network
itk::Statistics::NeuralNetworkObject< TMeasurementVector, TTargetVector >This is the itkNeuralNetworkObject class
itk::NiftiImageIOClass that defines how to read Nifti file format. Nifti IMAGE FILE FORMAT - As much information as I can determine from sourceforge.net/projects/Niftilib
itk::NiftiImageIOFactoryCreate instances of NiftiImageIO objects using an object factory
itk::Statistics::NNetDistanceMetricBase< TMeasurementVector >This is the itkNNetDistanceMetricBase class
itk::fem::Element::NodeClass that stores information required to define a node
itk::NodeOfPermutationA node to be used when computing permutations
itk::NodePair< TNode, TOutputPixel >Represents a Node and its associated value (front value)
itk::NoEvent
itk::NoiseImageFilter< TInputImage, TOutputImage >Calculate the local noise in an image
itk::NonLinearOptimizerWrap of the vnl_nonlinear_minimizer to be adapted
itk::NonThreadedShrinkImageFilter< TInputImage, TOutputImage >Reduce the size of an image by an integer factor
itk::NonUniformBSpline< TDimension >BSpline with nonuniform knot spacing
itk::NormalBandNode< TImageType >This is a data storage class that can is used as the node type for the SparseImage class
itk::NormalizedCorrelationImageFilter< TInputImage, TMaskImage, TOutputImage, TOperatorValueType >Computes the normalized correlation of an image and a template
itk::NormalizedCorrelationImageToImageMetric< TFixedImage, TMovingImage >Computes similarity between two images to be registered
itk::NormalizedCorrelationPointSetToImageMetric< TFixedPointSet, TMovingImage >Computes similarity between pixel values of a point set and intensity values of an image
itk::NormalizedMutualInformationHistogramImageToImageMetric< TFixedImage, TMovingImage >Computes normalized mutual information between two images to be registered using the histograms of the intensities in the images
itk::NormalizeImageFilter< TInputImage, TOutputImage >Normalize an image by setting its mean to zero and variance to one
itk::NormalizeToConstantImageFilter< TInputImage, TOutputImage >Scales image pixel intensities to make the sum of all pixels equal a user-defined constant
itk::NormalQuadEdgeMeshFilter< TInputMesh, TOutputMesh >Filter which computes normals to faces and vertices and store it in the output mesh. Normals to face are first computed, then normals to vertices are computed as linear combination of neighbor face normals, i.e.

\[ n_v = \frac{\sum_{i=0}^{N_f} \omega_i \cdot n_i}{\| \sum_{k=0}^{N_f} \omega_x \cdot n_k\|} \]

itk::Statistics::NormalVariateGeneratorNormal random variate generator
itk::NormalVectorDiffusionFunction< TSparseImageType >This class defines all the necessary functionality for performing isotropic and anisotropic diffusion operations on vector neighborhoods from a sparse image
itk::NormalVectorFunctionBase< TSparseImageType >This class defines the common functionality for Sparse Image neighborhoods of unit vectors
itk::Functor::NOT< TInput, TOutput >
itk::NotImageFilter< TInputImage, TOutputImage >Implements the NOT logical operator pixel-wise on an image
itk::Concept::NotOperator< T >
itk::NrrdImageIORead and write the "Nearly Raw Raster Data" (Nrrd) image format. The Nrrd format was developed as part of the Teem package (teem.sourceforge.net)
itk::NrrdImageIOFactoryCreate instances of NrrdImageIO objects using an object factory
itk::NthElementImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the N-th element of its pixels
itk::NthElementImageAdaptorHelper< TImage, TOutputPixelType >
itk::NthElementPixelAccessor< T, TContainer >Give access to the N-th of a Container type
itk::NumberOfFacesCriterion< TMesh, TElement, TMeasure, TPriorityQueueWrapper >
itk::Functor::NumberOfLinesLabelObjectAccessor< TLabelObject >
itk::Functor::NumberOfPixelsLabelObjectAccessor< TLabelObject >
itk::Functor::NumberOfPixelsOnBorderLabelObjectAccessor< TLabelObject >
itk::NumberOfPointsCriterion< TMesh, TElement, TMeasure, TPriorityQueueWrapper >
numeric_limits
itk::NumericSeriesFileNamesGenerate an ordered sequence of filenames
itk::NumericTraits< T >Define additional traits for native types such as int or float
itk::NumericTraits< Array< T > >NumericTraits for Array
itk::NumericTraits< CovariantVector< T, D > >Define numeric traits for CovariantVector
itk::NumericTraits< DiffusionTensor3D< T > >Define numeric traits for DiffusionTensor3D
itk::NumericTraits< FixedArray< T, D > >Define numeric traits for FixedArray
itk::NumericTraits< Point< T, D > >NumericTraits for Point
itk::NumericTraits< RGBAPixel< T > >Define numeric traits for RGBAPixel
itk::NumericTraits< RGBPixel< T > >Define numeric traits for RGBPixel
itk::NumericTraits< std::vector< T > >Define numeric traits for std::vector
itk::NumericTraits< SymmetricSecondRankTensor< T, D > >Define numeric traits for SymmetricSecondRankTensor
itk::NumericTraits< VariableLengthVector< T > >Define numeric traits for VariableLengthVector
itk::NumericTraits< Vector< T, D > >NumericTraits for Vector
itk::ObjectBase class for most ITK classes
itk::ObjectByObjectLabelMapFilter< TInputImage, TOutputImage, TInputFilter, TOutputFilter, TInternalInputImage, TInternalOutputImage >ObjectByObjectLabelMapFilter applies an image pipeline to all the objects of a label map and produce a new label map
itk::ObjectFactory< T >Create instances of a class
itk::ObjectFactoryBaseCreate instances of classes using an object factory
itk::ObjectMorphologyImageFilter< TInputImage, TOutputImage, TKernel >Base class for the morphological operations being applied to isolated objects in an image
itk::ObjectStore< TObjectType >A specialized memory management object for allocating and destroying contiguous blocks of objects
itk::ObjectToObjectMetricComputes similarity between regions of two objects
itk::ObjectToObjectOptimizerBaseAbstract base for object-to-object optimizers
itk::OBJMeshIOThis class defines how to read and write Object file format
itk::OBJMeshIOFactoryCreate instances of OBJMeshIO objects using an object factory
itk::Octree< TPixel, ColorTableSize, MappingFunctionType >Represent a 3D Image with an Octree data structure
itk::OctreeBaseProvides non-templated access to templated instances of Octree
itk::OctreeNodeA data structure representing a node in an Octree
itk::OctreeNodeBranch
itk::OFFMeshIOThis class defines how to read and write Object file format
itk::OFFMeshIOFactoryCreate instances of OFFMeshIO objects using an object factory
itk::Offset< VOffsetDimension >Represent the offset between two n-dimensional indexes in a n-dimensional image
itk::Functor::OffsetLexicographicCompare< VOffsetDimension >Order Offset instances lexicographically
itk::Statistics::OneHiddenLayerBackPropagationNeuralNetwork< TMeasurementVector, TTargetVector >This is the itkOneHiddenLayerBackPropagationNeuralNetwork class
itk::OnePlusOneEvolutionaryOptimizer1+1 evolutionary strategy optimizer
itk::OnesMatrixCoefficients< TInputMesh >Compute a matrix filled by 1s wherever two vertices are connected by an edge
itk::OneWayEquivalencyTableHash table to manage integral label equivalencies that are order dependent
itk::OpeningByReconstructionImageFilter< TInputImage, TOutputImage, TKernel >Opening by reconstruction of an image
itk::OptimizerGeneric representation for an optimization method
itk::OptimizerParameters< TValueType >Class to hold and manage different parameter types used during optimization
itk::OptimizerParameterScalesEstimatorOptimizerParameterScalesEstimator is the base class offering a empty method of estimating the parameter scales for optimizers
itk::OptimizerParametersHelper< TValueType >Basic helper class to manage parameter data as an Array type, the default type
itk::Functor::OR< TInput1, TInput2, TOutput >
itk::OrientImageFilter< TInputImage, TOutputImage >Permute axes and then flip images as needed to obtain agreement in coordinateOrientation codes
itk::OrImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements the OR logical operator pixel-wise between two images
itk::OrthogonallyCorrected2DParametricPathRepresent an orthogonally corrected 2D parametric path
itk::OrthogonalSwath2DPathFilter< TFourierSeriesPath, TSwathMeritImage >Filter that optimizes a 2D path relative to an image
itk::Concept::OStreamWritable< T >
itk::OtsuMultipleThresholdsCalculator< TInputHistogram >Computes Otsu's thresholds for a histogram
itk::OtsuMultipleThresholdsImageFilter< TInputImage, TOutputImage >Threshold an image using multiple Otsu Thresholds
itk::OtsuThresholdCalculator< THistogram, TOutput >Computes the Otsu's threshold for an image
itk::OtsuThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the Otsu Threshold
itk::OutputDataObjectConstIteratorA forward iterator over outputs of a ProcessObject
itk::OutputDataObjectIteratorA forward iterator over outputs of a ProcessObject
itk::OutputWindowMessages sent from the system are collected by this object
itk::ObjectFactoryBase::OverrideInformationInternal implementation class for ObjectFactorBase
itk::Function::OverUnderColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::PadImageFilter< TInputImage, TOutputImage >Increase the image size by padding. Superclass for filters that fill in extra pixels
itk::PadLabelMapFilter< TInputImage >Pad a LabelMap image
itk::ParallelSparseFieldCityBlockNeighborList< TNeighborhoodType >A convenience class for storing indicies which reference neighbor pixels within a neighborhood
itk::ParallelSparseFieldLevelSetImageFilter< TInputImage, TOutputImage >This class implements a finite difference partial differential equation solver for evolving surfaces embedded in volumes as level-sets
itk::ParallelSparseFieldLevelSetNode< TNodeIndexType >
itk::ParallelSparseFieldLevelSetImageFilter< TInputImage, TOutputImage >::ParallelSparseFieldLevelSetThreadStruct
itk::ParameterizationQuadEdgeMeshFilter< TInputMesh, TOutputMesh, TSolverTraits >Compute a planar parameterization of the input mesh
itk::ParametricImageSource< TOutputImage >Base class for all parametric image sources
itk::ParametricPath< VDimension >Represent a parametric path through ND Space
itk::ParametricSpaceToImageSpaceMeshFilter< TInputMesh, TOutputMesh >ParametricSpaceToImageSpaceMeshFilter takes an itk::Mesh on which the point Data is expected to contain itk::Index of itk::Image pixels associated with each point of the Mesh, and construct with them a new mesh whose points are in the coordinates of those pixels
itk::ParticleSwarmOptimizerBase::ParticleData
itk::ParticleSwarmOptimizerImplementation of a Particle Swarm Optimization (PSO) algorithm
itk::ParticleSwarmOptimizerBaseAbstract implementation of a Particle Swarm Optimization (PSO) algorithm
itk::PasteImageFilter< TInputImage, TSourceImage, TOutputImage >Paste an image into another image
itk::Path< TInput, TOutput, VDimension >Represent a path through ND Space
itk::PathAndImageToPathFilter< TInputPath, TInputImage, TOutputPath >Base class for filters that take both a path and an image as input and produce a path as output
itk::PathConstIterator< TImage, TPath >PathConstIterator iterates (traces) over a path through an image
itk::PathIterator< TImage, TPath >PathIterator iterates (traces) over a path through an image
itk::PathSource< TOutputPath >Base class for all process objects that output path data
itk::PathToChainCodePathFilter< TInputPath, TOutputChainCodePath >Filter that produces a chain code version of a path
itk::PathToImageFilter< TInputPath, TOutputImage >Base class for filters that take a Path as input and produce an image as output. Base class for filters that take a Path as input and produce an image as output. By default, if the user does not specify the size of the output image, the maximum size of the path's bounding box is used. The default spacing of the image is given by the spacing of the input path (currently assumed internally to be 1.0)
itk::PathToPathFilter< TInputPath, TOutputPath >Base class for filters that take a path as input and produce a path as output
itk::PCAShapeSignedDistanceFunction< TCoordRep, VSpaceDimension, TImage >Compute the signed distance from a N-dimensional PCA Shape
itk::PDEDeformableRegistrationFilter< TFixedImage, TMovingImage, TDisplacementField >Deformably register two images using a PDE algorithm
itk::PDEDeformableRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >
itk::Functor::PerimeterLabelObjectAccessor< TLabelObject >
itk::Functor::PerimeterOnBorderLabelObjectAccessor< TLabelObject >
itk::Functor::PerimeterOnBorderRatioLabelObjectAccessor< TLabelObject >
itk::PeriodicBoundaryCondition< TInputImage, TOutputImage >A function object that determines values outside of image boundaries according to periodic (wrap-around) conditions
itk::PermuteAxesImageFilter< TImage >Permutes the image axes according to a user specified order
itk::PhasedArray3DSpecialCoordinatesImage< TPixel >Templated 3D nonrectilinear-coordinate image class for phased-array "range" images
itk::PhysicalPointImageSource< TOutputImage >Generate an image of the physical locations of each pixel
itk::Functor::PhysicalSizeLabelObjectAccessor< TLabelObject >
itk::PickEvent
itk::PipelineMonitorImageFilter< TImageType >
PipelineMonitorImageSourceEnables monitoring, recording and debuging of the pipeline execution and information exchange
itk::PixelAccessor< TInternalType, TExternalType >Give access to partial aspects of a type
itk::PixelTraits< TPixelType >Traits for a pixel that define the dimension and component type
itk::PlaneSpatialObject< TDimension >
itk::PNGImageIOImageIO object for reading and writing PNG images
itk::PNGImageIOFactoryCreate instances of PNGImageIO objects using an object factory
itk::Point< TCoordRep, NPointDimension >A templated class holding a geometric point in n-Dimensional space
itk::Point1D
itk::PointBasedSpatialObject< TDimension >This class serves as the base class for point-based spatial objects
itk::PointSet< TPixelType, VDimension, TMeshTraits >A superclass of the N-dimensional mesh structure; supports point (geometric coordinate and attribute) definition
itk::PointSetFunction< TInputPointSet, TOutput, TCoordRep >Evaluates a function of an image at specified position
itk::PointSetToImageFilter< TInputPointSet, TOutputImage >Base class for filters that take a PointSet as input and produce an image as output. By default, if the user does not specify the size of the output image, the maximum size of the point-set's bounding box is used
itk::PointSetToImageMetric< TFixedPointSet, TMovingImage >Computes similarity between a point set and an image
itk::PointSetToImageRegistrationMethod< TFixedPointSet, TMovingImage >Base class for PointSet to Image Registration Methods
itk::Statistics::PointSetToListSampleAdaptor< TPointSet >This class provides ListSample interface to ITK PointSet
itk::PointSetToPointSetMetric< TFixedPointSet, TMovingPointSet >Computes similarity between two point sets
itk::PointSetToPointSetMetricv4< TFixedPointSet, TMovingPointSet >Computes similarity between two point sets
itk::PointSetToPointSetRegistrationMethod< TFixedPointSet, TMovingPointSet >Base class for PointSet to PointSet Registration Methods
itk::PointSetToSpatialObjectDemonsRegistration< TFixedPointSet, TMovingSpatialObject >Implementation of Demons Registration between a PointSet and a SpatialObject
itk::PointsLocator< TPointIdentifier, VPointDimension, TCoordRep, TPointsContainer >Accelerate geometric searches for points
itk::PolygonCell< TCellInterface >Represents a polygon in a Mesh
itk::PolygonGroupSpatialObject< TDimension >Implements a Region Of Interest Type
itk::PolygonGroupSpatialObjectXMLFileReader
itk::PolygonGroupSpatialObjectXMLFileWriter
itk::PolygonSpatialObject< TDimension >TODO
itk::PolylineMask2DImageFilter< TInputImage, TPolyline, TOutputImage >Implements 2D image masking operation constrained by a contour
itk::PolylineMaskImageFilter< TInputImage, TPolyline, TVector, TOutputImage >Implements image masking operation constrained by a polyline on a plane perpendicular to certain viewing direction
itk::PolyLineParametricPath< VDimension >Represent a path of line segments through ND Space
itk::PostOrderTreeIterator< TTreeType >
itk::Functor::Pow< TInput1, TInput2, TOutput >
itk::PowellOptimizerImplements Powell optimization using Brent line search
itk::PowImageFilter< TInputImage1, TInputImage2, TOutputImage >Computes the powers of 2 images
itk::PreOrderTreeIterator< TTreeType >
itk::Functor::PrincipalAxesLabelObjectAccessor< TLabelObject >
itk::Functor::PrincipalMomentsLabelObjectAccessor< TLabelObject >
itk::PriorityQueueContainer< TElementWrapper, TElementWrapperInterface, TElementPriority, TElementIdentifier >
itk::Statistics::ProbabilityDistributionProbabilityDistribution class defines common interface for statistical distributions (pdfs, cdfs, etc.)
itk::ProcessAborted
ProcessedOutputType
itk::ProcessObjectThe base class for all process objects (source, filters, mappers) in the Insight data processing pipeline
itk::ProcessObject::ProcessObjectDomainThreader< TDomainPartitioner, TAssociate >Multi-threaded processing on a domain by processing sub-domains per thread
itk::Statistics::ProductInputFunction< TMeasurementVector, ScalarType >This is the itkProductInputFunction class
itk::ProgressAccumulatorFacilitates progress reporting for filters that wrap around multiple other filters
itk::ProgressEvent
itk::ProgressReporterImplements progress tracking for a filter
itk::ProjectedIterativeDeconvolutionImageFilter< TSuperclass >Mix-in class that adds a projection step after each iteration
itk::ProjectedLandweberDeconvolutionImageFilter< TInputImage, TKernelImage, TOutputImage >Deconvolve an image using the projected Landweber deconvolution algorithm
itk::ProjectionImageFilter< TInputImage, TOutputImage, TAccumulator >Implements an accumulation of an image along a selected direction
itk::fftw::Proxy< TPixel >
itk::fftw::Proxy< double >
itk::fftw::Proxy< float >
itk::QuadEdgeBase class for the implementation of a quad-edge data structure as proposed in "Guibas and Stolfi 1985"
itk::QuadEdgeMesh< TPixel, VDimension, TTraits >Mesh class for 2D manifolds embedded in ND space
itk::QuadEdgeMeshBaseIterator< TQuadEdge >Base iterator class for QuadEdgeMesh
itk::QuadEdgeMeshBoundaryEdgesMeshFunction< TMesh >Build a list of references to edges (as GeometricalQuadEdge::RawPointer) each one representing a different boundary component
itk::QuadEdgeMeshConstFrontIterator< TMesh, TQE >Const quad edge mesh front iterator
itk::QuadEdgeMeshConstIterator< TQuadEdge >Const iterator for QuadEdgeMesh
itk::QuadEdgeMeshConstIteratorGeom< TGeometricalQuadEdge >Const geometrical iterator
itk::QuadEdgeMeshDecimationCriterion< TMesh, TElement, TMeasure, TPriorityQueueWrapper >
itk::QuadEdgeMeshDecimationQuadricElementHelper< TPoint >TODO explicit specification for VDimension=3!!!
itk::QuadEdgeMeshEulerOperatorCreateCenterVertexFunction< TMesh, TQEType >Create a vertex at the barycenter of the given face
itk::QuadEdgeMeshEulerOperatorDeleteCenterVertexFunction< TMesh, TQEType >Delete the vertex, connected edges and faces and create a new face in place of the previous vertex' one-ring
itk::QuadEdgeMeshEulerOperatorFlipEdgeFunction< TMesh, TQEType >Flip an edge
itk::QuadEdgeMeshEulerOperatorJoinFacetFunction< TMesh, TQEType >Join the two facets which are on both sides of a given internal edge
itk::QuadEdgeMeshEulerOperatorJoinVertexFunction< TMesh, TQEType >Collapse a given edge by joining its dest and its org
itk::QuadEdgeMeshEulerOperatorSplitEdgeFunction< TMesh, TQEType >Given Edge is splitted into two and associated faces see their degree increased by one (a triangle is transformed into a quad for example)
itk::QuadEdgeMeshEulerOperatorSplitFacetFunction< TMesh, TQEType >Given two edges h and g sharing the same Left() face, create a new edge joining h->Destination() to g->Destination(), thus splitting the original Left()
itk::QuadEdgeMeshEulerOperatorSplitVertexFunction< TMesh, TQEType >Split a vertex into two new connected vertices
itk::QuadEdgeMeshExtendedTraits< TPixelType, VPointDimension, VMaxTopologicalDimension, TCoordRep, TInterpolationWeightType, TCellPixelType, TPData, TDData >Extended traits for a QuadEdgeMesh
itk::QuadEdgeMeshFrontBaseIterator< TMesh, TQE >Front iterator on Mesh class
itk::QuadEdgeMeshFrontIterator< TMesh, TQE >Non const quad edge front iterator
itk::QuadEdgeMeshFunctionBase< TMesh, TOutput >
itk::QuadEdgeMeshIterator< TQuadEdge >Non const iterator for QuadMesh
itk::QuadEdgeMeshIteratorGeom< TGeometricalQuadEdge >Non const geometrical iterator
itk::QuadEdgeMeshLineCell< TCellInterface >Class that connects the QuadEdgeMesh with the Mesh
itk::QuadEdgeMeshPoint< TCoordRep, VPointDimension, TQuadEdge >Wrapper around a itk::Point in order to add a reference to an entry in the edge ring
itk::QuadEdgeMeshPolygonCell< TCellInterface >
QuadEdgeMeshScalarDataVTKPolyDataThis class saves a QuadMesh into a VTK-legacy file format, including its scalar data associated with points
itk::QuadEdgeMeshScalarDataVTKPolyDataWriter< TMesh >
itk::QuadEdgeMeshTopologyChecker< TMesh >Make some basic checks in order to verify that the considered mesh is not degenerated and correctly represents a surface with a potential boundary
itk::QuadEdgeMeshToQuadEdgeMeshFilter< TInputMesh, TOutputMesh >Duplicates the content of a Mesh
itk::QuadEdgeMeshTraits< TPixel, VPointDimension, TPData, TDData, TCoordRep, TInterpolationWeight >Class holding the traits of the QuadEdgeMesh
itk::QuadEdgeMeshZipMeshFunction< TMesh, TQEType >Fuse the incoming edge and it's Onext() follower (like a zipper does)
itk::QuadraticEdgeCell< TCellInterface >Represents a second order line segment for a Mesh
itk::QuadraticTriangleCell< TCellInterface >Represents a second order triangular patch for a Mesh
itk::QuadraticTriangleCellTopologyQuadraticTriangleCellTopology holds data defining the topological connections of the vertices and edges of a TriangleCell
itk::QuadricDecimationQuadEdgeMeshFilter< TInput, TOutput, TCriterion >Quadric decimation
itk::QuadrilateralCell< TCellInterface >Represents a quadrilateral for a Mesh
itk::QuadrilateralCellTopologyHolds data defining the topological connections of the vertices and edges of a QuadrilateralCell
itk::QuasiNewtonOptimizerv4Implement a Quasi-Newton optimizer with BFGS Hessian estimation
itk::QuasiNewtonOptimizerv4EstimateNewtonStepThreaderEstimate the quasi-Newton step in a thread
itk::QuaternionOrientationAdapter< VDimension >Converts QuaternionOrientation flags to/from direction cosines
itk::QuaternionRigidTransform< TScalarType >QuaternionRigidTransform of a vector space (e.g. space coordinates)
itk::QuaternionRigidTransformGradientDescentOptimizerImplement a gradient descent optimizer
itk::Statistics::QuickPropLearningRule< LayerType, TTargetVector >The QuickPropLearningRule is the base class for all the ErrorBackPropagationLearning strategies
itk::Statistics::RadialBasisFunctionBase< ScalarType >This is the itkRadialBasisFunctionBase class
itk::RandomImageSource< TOutputImage >Generate an n-dimensional image of random pixel values
itk::RandomPermutationProduce a random permutation of a collection
itk::Statistics::RandomVariateGeneratorBaseDefines common interfaces for random variate generators
itk::RangeError
itk::Function::RankHistogram< TInputPixel >
itk::RankImageFilter< TInputImage, TOutputImage, TKernel >Rank filter of a greyscale image
itk::RawImageIO< TPixel, VImageDimension >Read and write raw binary images
itk::RawImageIOFactory< TPixel, VImageDimension >
itk::RayCastInterpolateImageFunction< TInputImage, TCoordRep >Projective interpolation of an image at specified positions
itk::Statistics::RBFBackPropagationLearningFunction< LayerType, TTargetVector >This is the itkRBFBackPropagationLearningFunction class
itk::Statistics::RBFLayer< TMeasurementVector, TTargetVector >This is the itkRBFLayer class
itk::Statistics::RBFNetwork< TMeasurementVector, TTargetVector >This is the itkRBFNetwork class
itk::RealTimeClockProvides a timestamp from a real-time clock
itk::RealTimeIntervalA data structure for representing the time span between two RealTimeStamps, with similar high precision and a large dynamic range to what the RealTimeStamps offer
itk::RealTimeStampThe RealTimeStamp is a data structure for representing time with high precision and a large dynamic range
itk::RealToHalfHermitianForwardFFTImageFilter< TInputImage, TOutputImage >Base class for specialized real-to-complex forward Fast Fourier Transform
itk::ImageAdaptor< TImage, TAccessor >::Rebind< UPixelType, UImageDimension >
itk::Image< TPixel, VImageDimension >::Rebind< UPixelType, UImageDimension >
itk::VectorImage< TPixel, VImageDimension >::Rebind< UPixelType, UImageDimension >A structure which enable changing any image class' pixel type to another
itk::ReceptorMemberCommand< T >A Command subclass that calls a pointer to a member function
itk::ReconstructionByDilationImageFilter< TInputImage, TOutputImage >Grayscale reconstruction by dilation of an image
itk::ReconstructionByErosionImageFilter< TInputImage, TOutputImage >Grayscale reconstruction by erosion of an image
itk::ReconstructionImageFilter< TInputImage, TOutputImage, TCompare >Performs a grayscale geodesic reconstruction -- for performance comparison with GrayscaleGeodesicDilateImageFilter
itk::RecursiveGaussianImageFilter< TInputImage, TOutputImage >Base class for computing IIR convolution with an approximation of a Gaussian kernel
itk::RecursiveMultiResolutionPyramidImageFilter< TInputImage, TOutputImage >Creates a multi-resolution pyramid using a recursive implementation
itk::RecursiveSeparableImageFilter< TInputImage, TOutputImage >Base class for recursive convolution with a kernel
itk::Function::RedColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
RedirectOutputParameters
itk::RedPixelAccessor< T >Give access to the red component of a RGBPixel type
itk::ExceptionObject::ReferenceCounterInterface
itk::ReflectImageFilter< TInputImage, TOutputImage >Implements a Reflection of an image along a selected direction
itk::ReflectiveImageRegionConstIterator< TImage >Multi-dimensional image iterator which only walks a region
itk::ReflectiveImageRegionIterator< TImage >Multi-dimensional image iterator which only walks a region
itk::RegionA region represents some portion or piece of data
itk::RegionalMaximaImageFilter< TInputImage, TOutputImage >Produce a binary image where foreground is the regional maxima of the input image
itk::RegionalMinimaImageFilter< TInputImage, TOutputImage >Produce a binary image where foreground is the regional minima of the input image
itk::RegionBasedLevelSetFunction< TInput, TFeature, TSharedData >LevelSet function that computes a speed image based on regional integrals
itk::RegionBasedLevelSetFunctionData< TInputImage, TFeatureImage >Helper class used to share data in the ScalarChanAndVeseLevelSetFunction
itk::RegionBasedLevelSetFunctionSharedData< TInputImage, TFeatureImage, TSingleData >Helper class used to share data in the ScalarChanAndVeseLevelSetFunction
itk::RegionFromReferenceLabelMapFilter< TInputImage >Set the region from a reference image
itk::RegionGrowImageFilter< TInputImage, TOutputImage >Base class for RegionGrowImageFilter object
itk::RegionOfInterestImageFilter< TInputImage, TOutputImage >Extract a region of interest from the input image
itk::NarrowBand< NodeType >::RegionStruct
itk::SparseFieldLayer< TNodeType >::RegionType
itk::RegistrationParameterScalesEstimator< TMetric >Implements a registration helper class for estimating scales of transform parameters
itk::RegistrationParameterScalesFromJacobian< TMetric >Implements a registration helper class for estimating scales of transform parameters from Jacobian norms
itk::RegistrationParameterScalesFromShift< TMetric >Implements a registration helper class for estimating scales of transform parameters from the maximum voxel shift caused by a parameter change
RegressionTestParameters
itk::RegularExpressionSeriesFileNamesGenerate an ordered sequence of filenames that match a regular expression
itk::RegularizedHeavisideStepFunction< TInput, TOutput >Base class of the Regularized (smoothed) Heaviside functions
itk::RegularSphereMeshSource< TOutputMesh >Inputs are the center of the mesh, the scale (radius in each dimension) of the mesh and a resolution parameter, which corresponds to the recursion depth whlie creating a spherical triangle mesh
itk::RegularStepGradientDescentBaseOptimizerImplement a gradient descent optimizer
itk::RegularStepGradientDescentOptimizerImplement a gradient descent optimizer
itk::ReinitializeLevelSetImageFilter< TLevelSet >Reinitialize the level set to the signed distance function
itk::RelabelComponentImageFilter< TInputImage, TOutputImage >Relabel the components in an image such that consecutive labels are used
itk::RelabelComponentImageFilter< TInputImage, TOutputImage >::RelabelComponentObjectType
itk::RelabelComponentImageFilter< TInputImage, TOutputImage >::RelabelComponentSizeInPixelsComparator
itk::watershed::Relabeler< TScalarType, TImageDimension >
itk::RelabelLabelMapFilter< TImage >This filter relabels the LabelObjects; the new labels are arranged consecutively with consideration for the background value
itk::RenyiEntropyThresholdCalculator< THistogram, TOutput >Computes the RenyiEntropy's threshold for an image
itk::RenyiEntropyThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the RenyiEntropy Threshold
itk::ResampleImageFilter< TInputImage, TOutputImage, TInterpolatorPrecisionType >Resample an image via a coordinate transform
itk::RescaleIntensityImageFilter< TInputImage, TOutputImage >Applies a linear transformation to the intensity levels of the input Image
itk::ResourceProbe< ValueType, MeanType >Computes the change of a value between two points in code
itk::ResourceProbesCollectorBase< TProbe >Aggregates a set of probes
itk::AttributeKeepNObjectsLabelMapFilter< TImage, TAttributeAccessor >::ReverseComparator
itk::AttributeRelabelLabelMapFilter< TImage, TAttributeAccessor >::ReverseComparator
itk::FixedArray< TValueType, VLength >::ReverseIteratorA reverse iterator through an array
itk::RGBAPixel< TComponent >Represent Red, Green, Blue and Alpha components for color images
itk::RGBGibbsPriorFilter< TInputImage, TClassifiedImage >The RGBGibbsPriorFilter applies Gibbs Prior model for the segmentation of MRF images
itk::RGBPixel< TComponent >Represent Red, Green and Blue components for color images
itk::Functor::RGBToLuminance< TInput, TOutput >
itk::RGBToLuminanceImageAdaptor< TImage, TOutputPixelType >Presents a color image as being composed of the Luminance of its pixels
itk::RGBToLuminanceImageFilter< TInputImage, TOutputImage >Converts an RGB image into a grayscale image
itk::Accessor::RGBToLuminancePixelAccessor< TInternalType, TExternalType >Give access to Luminance of a color pixel type
itk::RGBToVectorImageAdaptor< TImage >Presents an image of pixel type RGBPixel as being and image of Vectors
itk::Accessor::RGBToVectorPixelAccessor< T >Give access to a RGBPixel as if it were a Vector type
itk::RichardsonLucyDeconvolutionImageFilter< TInputImage, TKernelImage, TOutputImage >Deconvolve an image using the Richardson-Lucy deconvolution algorithm
itk::Rigid2DTransform< TScalarType >Rigid2DTransform of a vector space (e.g. space coordinates)
itk::Rigid3DPerspectiveTransform< TScalarType >Rigid3DTramsform of a vector space (e.g. space coordinates)
itkv3::Rigid3DTransform< TScalarType >ITK3.x compatible Rigid3DTransform of a vector space (e.g. space coordinates)
itk::Rigid3DTransform< TScalarType >Rigid3DTransform of a vector space (e.g. space coordinates)
itk::RingBuffer< TElement >Templated ring buffer for holding anything
itk::RobustAutomaticThresholdCalculator< TInputImage, TGradientImage >Compute the robust automatic threshold
itk::RobustAutomaticThresholdImageFilter< TInputImage, TGradientImage, TOutputImage >Threshold an image using robust automatic threshold selection (RATS) method
itk::RootTreeIterator< TTreeType >
itk::Functor::Round< TInput, TOutput >
itk::RoundImageFilter< TInputImage, TOutputImage >Rounds the value of each pixel
itk::Functor::RoundnessLabelObjectAccessor< TLabelObject >
itk::ConnectedComponentImageFilter< TInputImage, TOutputImage, TMaskImage >::runLength
itk::BinaryImageToLabelMapFilter< TInputImage, TOutputImage >::runLength
itk::BinaryContourImageFilter< TInputImage, TOutputImage >::runLength
itk::LabelContourImageFilter< TInputImage, TOutputImage >::RunLength
itk::Concept::SameDimension< D1, D2 >
itk::Concept::SameDimensionOrMinusOne< D1, D2 >
itk::Concept::SameDimensionOrMinusOneOrTwo< D1, D2 >
itk::Concept::SameType< T1, T2 >
itk::Statistics::Sample< TMeasurementVector >A collection of measurements for statistical analysis
itk::Statistics::SampleClassifierFilter< TSample >Sample classification class
itk::Statistics::SampleToHistogramFilter< TSample, THistogram >Computes the Histogram corresponding to a Sample
itk::Statistics::SampleToSubsampleFilter< TSample >Base class of filters intended to select subsamples from samples
itk::ScalableAffineTransform< TScalarType, NDimensions >Affine transformation with a specified center of rotation
itk::ScalarAnisotropicDiffusionFunction< TImage >
itk::ScalarChanAndVeseDenseLevelSetImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, TSharedData >Dense implementation of the Chan and Vese multiphase level set image filter
itk::ScalarChanAndVeseLevelSetFunction< TInputImage, TFeatureImage, TSharedData >LevelSet function that computes a speed image based on regional integrals of probabilities
itk::ScalarChanAndVeseLevelSetFunctionData< TInputImage, TFeatureImage >Helper class used to share data in the ScalarChanAndVeseLevelSetFunction
itk::ScalarChanAndVeseSparseLevelSetImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, TSharedData, TIdCell >Sparse implementation of the Chan and Vese multiphase level set image filter
itk::ScalarConnectedComponentImageFilter< TInputImage, TOutputImage, TMaskImage >A connected components filter that labels the objects in an arbitrary image. Two pixels are similar if they are within threshold of each other. Uses ConnectedComponentFunctorImageFilter
itk::ScalarImageKmeansImageFilter< TInputImage, TOutputImage >Classifies the intensity values of a scalar image using the K-Means algorithm
itk::Statistics::ScalarImageToCooccurrenceListSampleFilter< TImage >Converts pixel data into a list of pairs in order to compute a cooccurrence Histogram
itk::Statistics::ScalarImageToCooccurrenceMatrixFilter< TImageType, THistogramFrequencyContainer >This class computes a co-occurence matrix (histogram) from a given image and a mask image if provided. Coocurrence matrces are used for image texture description
itk::Statistics::ScalarImageToHistogramGenerator< TImageType >TODO
itk::Statistics::ScalarImageToRunLengthFeaturesFilter< TImageType, THistogramFrequencyContainer >This class computes run length descriptions from an image
itk::Statistics::ScalarImageToRunLengthMatrixFilter< TImageType, THistogramFrequencyContainer >This class computes a run length matrix (histogram) from a given image and a mask image if provided. Run length matrces are used for image texture description
itk::Statistics::ScalarImageToTextureFeaturesFilter< TImageType, THistogramFrequencyContainer >This class computes texture descriptions from an image
itk::ScalarRegionBasedLevelSetFunction< TInputImage, TFeatureImage, TSharedData >LevelSet function that computes a speed image based on regional integrals
itk::ScalarToArrayCastImageFilter< TInputImage, TOutputImage >Creates the output image with vector type pixels filled with the intensity values from one or more input images with scalar pixels
itk::ScalarToRGBColormapImageFilter< TInputImage, TOutputImage >Implements pixel-wise intensity->rgb mapping operation on one image
itk::Functor::ScalarToRGBPixelFunctor< TScalar >A Function object which maps a scalar value into an RGB pixel value
itk::ScalarVector< TScalar, TVector, TVectorDimension >A templated class holding bot scalar and vector values and responding to the GetScalar() and GetVector() methods
itk::ScaleLogarithmicTransform< TScalarType, NDimensions >Logarithmic Scale transformation of a vector space (e.g. space coordinates)
itk::ScaleSkewVersor3DTransform< TScalarType >ScaleSkewVersor3DTransform of a vector space (e.g. space coordinates)
itk::ScaleTransform< TScalarType, NDimensions >Scale transformation of a vector space (e.g. space coordinates)
itk::ScaleVersor3DTransform< TScalarType >This transform applies a Versor rotation, translation and anisotropic scale to the space
itk::ANTSNeighborhoodCorrelationImageToImageMetricv4< TFixedImage, TMovingImage, TVirtualImage >::ScanMemType
itk::ANTSNeighborhoodCorrelationImageToImageMetricv4< TFixedImage, TMovingImage, TVirtualImage >::ScanParametersType
itk::ScatterMatrixImageFunction< TInputImage, TCoordRep >Calculate the scatter matrix in the neighborhood of a pixel in a Vector image
itk::SceneSpatialObject< TSpaceDimension >SceneSpatialObject has a list of SpatialObjects
itk::watershed::SegmentTable< TScalarType >::segment_t
itk::SegmentationBorderBase class for SegmentationBorder object
itk::SegmentationLevelSetFunction< TImageType, TFeatureImageType >
itk::SegmentationLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >A base class which defines the API for implementing a special class of image segmentation filters using level set methods
itk::SegmentationRegionBase class for SegmentationRegion object
itk::watershed::Segmenter< TInputImage >
itk::watershed::SegmentTable< TScalarType >
itk::watershed::SegmentTree< TScalarType >
itk::watershed::SegmentTreeGenerator< TScalarType >
itk::SemaphoreThe semaphore class is used to synchronize execution between threads
itk::ShanbhagThresholdCalculator< THistogram, TOutput >Computes the Shanbhag threshold for an image. Aka intermeans
itk::ShanbhagThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the Shanbhag Threshold
itk::ShapeDetectionLevelSetFunction< TImageType, TFeatureImageType >This function is used in the ShapeDetectionLevelSetImageFilter to segment structures in an image based on a user supplied edge potential map
itk::ShapeDetectionLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on a user supplied edge potential map
itk::ShapedFloodFilledFunctionConditionalConstIterator< TImage, TFunction >Iterates over a flood-filled spatial function with read-only access to pixels
itk::ShapedFloodFilledImageFunctionConditionalConstIterator< TImage, TFunction >Iterates over a flood-filled image function with read-only access to pixels
itk::ShapedFloodFilledImageFunctionConditionalIterator< TImage, TFunction >Iterates over a flood-filled image function with write access to pixels
itk::ShapedNeighborhoodIterator< TImage, TBoundaryCondition >A neighborhood iterator which can take on an arbitrary shape
itk::ShapeKeepNObjectsLabelMapFilter< TImage >Keep N objects according to their shape attributes
itk::ShapeLabelMapFilter< TImage, TLabelImage >The valuator class for the ShapeLabelObject
itk::ShapeLabelObject< TLabel, VImageDimension >A Label object to store the common attributes related to the shape of the object
itk::ShapeOpeningLabelMapFilter< TImage >Remove objects according to the value of their shape attribute
itk::ShapePositionLabelMapFilter< TImage >Mark a single pixel in the label object which correspond to a position given by an attribute
itk::ShapePriorSegmentationLevelSetFunction< TImageType, TFeatureImageType >::ShapePriorGlobalDataStruct
itk::ShapePriorMAPCostFunction< TFeatureImage, TOutputPixel >Represents the maximum aprior (MAP) cost function used ShapePriorSegmentationLevelSetImageFilter to estimate the shape paramaeters
itk::ShapePriorMAPCostFunctionBase< TFeatureImage, TOutputPixel >Represents the base class of maximum aprior (MAP) cost function used ShapePriorSegmentationLevelSetImageFilter to estimate the shape paramaeters
itk::ShapePriorSegmentationLevelSetFunction< TImageType, TFeatureImageType >This function is used in ShapePriorSegmentationLevelSetFilter to segment structures in an image based on user supplied edge potential map and shape model
itk::ShapePriorSegmentationLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >A base class which defines the API for implementing a level set segmentation filter with statistical shape influence
itk::ShapeRelabelImageFilter< TInputImage >Relabel objects according to their shape attributes
itk::ShapeRelabelLabelMapFilter< TImage >Relabels objects according to their shape attributes
itk::ShapeSignedDistanceFunction< TCoordRep, VSpaceDimension >Base class for functions which evaluates the signed distance from a shape
itk::ShapeUniqueLabelMapFilter< TImage >Remove some pixels in the label object according to the value of their shape attribute to ensure that a pixel is not in to objects
itk::ShiftScaleImageFilter< TInputImage, TOutputImage >Shift and scale the pixels in an image
itk::ShiftScaleInPlaceImageFilter< TInputImage >Shift and scale the pixels in an image
itk::ShiftScaleLabelMapFilter< TImage >Shifts and scales a label map filter, giving the option to change the background value
itk::ShiSparseLevelSetImage< VDimension >Derived class for the shi representation of level-set function
itk::ShrinkImageFilter< TInputImage, TOutputImage >Reduce the size of an image by an integer factor in each dimension
itk::SiemensVisionImageIOClass that defines how to read SiemensVision file format
itk::SiemensVisionImageIOFactoryCreate instances of SiemensVisionImageIO objects using an object factory
itk::Functor::Sigmoid< TInput, TOutput >
itk::SigmoidImageFilter< TInputImage, TOutputImage >Computes the sigmoid function pixel-wise
itk::Statistics::SigmoidTransferFunction< ScalarType >This is the itkSigmoidTransferFunction class
itk::Concept::Signed< T >
itk::SignedDanielssonDistanceMapImageFilter< TInputImage, TOutputImage, TVoronoiImage >
itk::Statistics::SignedHardLimitTransferFunction< ScalarType >This is the itkSignedHardLimitTransferFunction class
itk::SignedMaurerDistanceMapImageFilter< TInputImage, TOutputImage >This filter calculates the Euclidean distance transform of a binary image in linear time for arbitrary dimensions
itk::Similarity2DTransform< TScalarType >Similarity2DTransform of a vector space (e.g. space coordinates)
itk::Similarity3DTransform< TScalarType >Similarity3DTransform of a vector space (e.g. space coordinates)
itk::SimilarityIndexImageFilter< TInputImage1, TInputImage2 >Measures the similarity between the set of non-zero pixels of two images
itk::Functor::SimilarPixelsFunctor< TInput >
itk::Functor::SimilarVectorsFunctor< TInput >A connected components filter that labels the objects in a vector image. Two vectors are pointing similar directions if one minus their dot product is less than a threshold. Vectors that are 180 degrees out of phase are similar. Assumes that vectors are normalized
itk::SimpleConstMemberCommand< T >A Command subclass that calls a pointer to a member function
itk::SimpleContourExtractorImageFilter< TInputImage, TOutputImage >Computes an image of contours which will be the contour of the first image
itk::SimpleDataObjectDecorator< T >Decorates any "simple" data type (data types without smart pointers) with a DataObject API
itk::SimpleFastMutexLockCritical section locking class that can be allocated on the stack
itk::SimpleFilterWatcherSimple mechanism for monitoring the pipeline events of a filter and reporting these events to std::cout
itk::MultivariateLegendrePolynomial::SimpleForwardIteratorIterator which only supports forward iteration and Begin(), IsAtEnd(), and Get() method which work just like as SimpleImageRegionIterator
itk::SimpleMemberCommand< T >A Command subclass that calls a pointer to a member function
SimpleMultiResolutionImageRegistrationUI< TRegistrator >
SimpleMultiResolutionImageRegistrationUI2< TRegistration >
itk::SimpleMutexLockSimple mutual exclusion locking class
itk::SimpleWisdomFilenameGenerator
itk::SimplexMeshToTriangleMeshFilter< TInputMesh, TOutputMesh >::SimplexCellVisitor
itk::SimplexMeshAdaptTopologyFilter< TInputMesh, TOutputMesh >::SimplexCellVisitor
itk::SimplexMeshVolumeCalculator< TInputMesh >::SimplexCellVisitor
itk::SimplexMesh< TPixelType, VDimension, TMeshTraits >The class represents a 2-simplex mesh
itk::SimplexMeshAdaptTopologyFilter< TInputMesh, TOutputMesh >This filter changes the topology of a 2-simplex mesh
itk::SimplexMeshGeometryHandle geometric properties for vertices of a simplx mesh
itk::SimplexMeshToTriangleMeshFilter< TInputMesh, TOutputMesh >This filter converts a 2-simplex mesh into a triangle mesh
itk::SimplexMeshVolumeCalculator< TInputMesh >Adapted from itkSimplexMeshToTriangleFilter to calculate the volume of a simplex mesh using the barycenters and normals. call Compute() to calculate the volume and GetVolume() to get the value. For an example see itkDeformableSimplexMesh3DFilter.cxx (Thomas Boettger. Division Medical and Biological Informatics, German Cancer Research Center, Heidelberg.)
itk::Functor::Sin< TInput, TOutput >
itk::SingleValuedCostFunctionThis class is a base for the CostFunctions returning a single value
itk::SingleValuedCostFunctionv4This class is a base for a CostFunction that returns a single value
itk::SingleValuedNonLinearOptimizerThis class is a base for the Optimization methods that optimize a single valued function
itk::SingleValuedNonLinearVnlOptimizerThis class is a base for the Optimization methods that optimize a single valued function
itk::SingleValuedVnlCostFunctionAdaptorThis class is an Adaptor that allows to pass itk::SingleValuedCostFunctions to vnl_optimizers expecting a vnl_cost_function
itk::SinImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_sin() of its pixels
itk::SinImageFilter< TInputImage, TOutputImage >Computes the sine of each pixel
itk::Accessor::SinPixelAccessor< TInternalType, TExternalType >Give access to the vcl_sin() function of a value
itk::SinRegularizedHeavisideStepFunction< TInput, TOutput >Sin-based implementation of the Regularized (smoothed) Heaviside functions
itk::Size< VDimension >Represent the size (bounds) of a n-dimensional image
itk::Functor::SkewnessLabelObjectAccessor< TLabelObject >
itk::SliceBySliceImageFilter< TInputImage, TOutputImage, TInputFilter, TOutputFilter, TInternalInputImage, TInternalOutputImage >Apply a filter or a pipeline slice by slice on an image
itk::SliceIterator< TPixel, TContainer >A flexible iterator for itk containers(i.e. itk::Neighborhood) that support pixel access through operator[]
itk::SmapsData_2_6Read a smaps stream and return the memory usage information. Smaps files have been added since the linux kernel 2.6
itk::SmapsFileParser< TSmapsDataType >Read a smap file (typically located in /proc/PID/smaps) and extract the memory usage information. Any smaps data reader can be used in template as long as they implement a operator>>(istream&) and have GetXXXUsage() methods
itk::SmapsRecordAn entry in a smaps file
itk::SmartPointer< TObjectType >Implements transparent reference counting
itk::SmartPointerForwardReference< T >Implements transparent reference counting in situations where forward references / cyclic include dependencies are a problem
itk::SmoothingQuadEdgeMeshFilter< TInputMesh, TOutputMesh >Quad Edge Mesh Smoothing Filter
itk::SmoothingRecursiveGaussianImageFilter< TInputImage, TOutputImage >Computes the smoothing of an image by convolution with the Gaussian kernels implemented as IIR filters
itk::SobelEdgeDetectionImageFilter< TInputImage, TOutputImage >A 2D or 3D edge detection using the Sobel operator
itk::SobelOperator< TPixel, VDimension, TAllocator >A NeighborhoodOperator for performing a directional Sobel edge-detection operation at a pixel location
itk::fem::SolutionProvides functions to access the values of the solution vector
itk::fem::Solver< VDimension >FEM solver used to generate a solution for a FE formulation
itk::fem::SolverCrankNicolson< TDimension >FEM Solver for time dependent problems; uses Crank-Nicolson implicit discretization scheme
itk::fem::SolverHyperbolic< TDimension >Solver class suitable for hyperbolic problems.M*ddu + C*du + K*u=F
itk::watershed::SegmentTree< TScalarType >::sort_comp
itk::MultiphaseSparseFiniteDifferenceImageFilter< TInputImage, TFeatureImage, TOutputImage, TFunction, TIdCell >::SparseDataStruct
itk::SparseFieldCityBlockNeighborList< TNeighborhoodType >A convenience class for storing indicies which reference neighbor pixels within a neighborhood
itk::SparseFieldFourthOrderLevelSetImageFilter< TInputImage, TOutputImage >This class implements the fourth order level set PDE framework
itk::SparseFieldLayer< TNodeType >A very simple linked list that is used to manage nodes in a layer of a sparse field level-set solver
itk::SparseFieldLayerIterator< TNodeType >The non-const version of the ConstSparseFieldLayerIterator
itk::SparseFieldLevelSetImageFilter< TInputImage, TOutputImage >This class implements a finite difference partial differential equation solver for evolving surfaces embedded in volumes as level-sets
itk::SparseFieldLevelSetNode< TValueType >
itk::Statistics::SparseFrequencyContainer2His class is a container for an histogram
itk::SparseImage< TNode, VImageDimension >A storage type for sparse image data
itk::SpatialFunction< TOutput, VImageDimension, TInput >N-dimensional spatial function class
itk::SpatialFunctionImageEvaluatorFilter< TSpatialFunction, TInputImage, TOutputImage >Evaluates a SpatialFunction onto a source image
itk::SpatialObject< VDimension >Implementation of the composite pattern
itk::SpatialObjectDuplicator< TInputSpatialObject >
itk::SpatialObjectFactory< T >Create instances of SpatialObjects
itk::SpatialObjectFactoryBaseCreate instances of SpatialObjects
itk::SpatialObjectPoint< TPointDimension >Point used for spatial objets
itk::SpatialObjectProperty< TComponentType >
itk::SpatialObjectReader< NDimensions, PixelType, TMeshTraits >TODO
itk::SpatialObjectToImageFilter< TInputSpatialObject, TOutputImage >Base class for filters that take a SpatialObject as input and produce an image as output. By default, if the user does not specify the size of the output image, the maximum size of the object's bounding box is used. The spacing of the image is given by the spacing of the input Spatial object
itk::SpatialObjectToImageStatisticsCalculator< TInputImage, TInputSpatialObject, TSampleDimension >
itk::SpatialObjectToPointSetFilter< TInputSpatialObject, TOutputPointSet >Base class for filters that take a SpatialObject as input and produce a PointSet as output. The pointset created is in physical space
itk::SpatialObjectTreeContainer< TDimension >Array class with size defined at construction time
itk::SpatialObjectTreeNode< TDimension >TODO
itk::SpatialObjectWriter< NDimensions, PixelType, TMeshTraits >TODO
itk::SpatialOrientationAdapterConverts SpatialOrientation flags to/from direction cosines
itk::MutualInformationImageToImageMetric< TFixedImage, TMovingImage >::SpatialSample
itk::SpecialCoordinatesImage< TPixel, VImageDimension >Templated n-dimensional nonrectilinear-coordinate image base class
itk::SphereSignedDistanceFunction< TCoordRep, VSpaceDimension >Compute the signed distance from a N-dimensional sphere
itk::SphereSpatialFunction< VImageDimension, TInput >Spatial function implementation of a sphere
itk::Function::SpringColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::SPSAOptimizerAn optimizer based on simultaneous perturbation..
itk::GradientMagnitudeRecursiveGaussianImageFilter< TInputImage, TOutputImage >::SqrSpacing
itk::Functor::Sqrt< TInput, TOutput >
itk::SqrtImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_sqrt() of its pixels
itk::SqrtImageFilter< TInputImage, TOutputImage >Computes the square root of each pixel
itk::Accessor::SqrtPixelAccessor< TInternalType, TExternalType >Give access to the vcl_sqrt() function of a value
itk::Functor::Square< TInput, TOutput >
itk::Functor::SquaredDifference2< TInput1, TInput2, TOutput >
itk::Statistics::SquaredDifferenceErrorFunction< TMeasurementVector, ScalarType >This is the itkSquaredDifferenceErrorFunction class
itk::SquaredDifferenceImageFilter< TInputImage1, TInputImage2, TOutputImage >Implements pixel-wise the computation of squared difference
itk::SquaredEdgeLengthDecimationQuadEdgeMeshFilter< TInput, TOutput, TCriterion >
itk::SquareImageFilter< TInputImage, TOutputImage >Computes the square of the intensity values pixel-wise
itk::Functor::StandardDeviationAccumulator< TInputPixel, TAccumulate >
itk::Functor::StandardDeviationLabelObjectAccessor< TLabelObject >
itk::Statistics::StandardDeviationPerComponentSampleFilter< TSample >Calculates the covariance matrix of the target sample data
itk::StandardDeviationProjectionImageFilter< TInputImage, TOutputImage, TAccumulate >Mean projection
itk::STAPLEImageFilter< TInputImage, TOutputImage >The STAPLE filter implements the Simultaneous Truth and Performance Level Estimation algorithm for generating ground truth volumes from a set of binary expert segmentations
itk::StartEvent
itk::StartPickEvent
itk::StatisticsImageFilter< TInputImage >Compute min. max, variance and mean of an Image
itk::StatisticsKeepNObjectsLabelMapFilter< TImage >Keep N objects according to their statistics attributes
itk::StatisticsLabelMapFilter< TImage, TFeatureImage >The valuator class for the ShapeLabelObject
itk::StatisticsLabelObject< TLabel, VImageDimension >A Label object to store the common attributes related to the statistics of the object
itk::StatisticsOpeningLabelMapFilter< TImage >Remove the objects according to the value of their statistics attribute
itk::StatisticsPositionLabelMapFilter< TImage >Mark a single pixel in the label object which correspond to a position given by an attribute
itk::StatisticsRelabelImageFilter< TInputImage, TFeatureImage >Relabel objects according to their shape attributes
itk::StatisticsRelabelLabelMapFilter< TImage >Relabel objects according to their shape attributes
itk::StatisticsUniqueLabelMapFilter< TImage >Remove some pixels in the label object according to the value of their statistics attribute to ensure that a pixel is not in to objects
itk::StdStreamLogOutputRepresents a standard stream output stream
itk::StimulateImageIOImageIO class for reading SDT/SPR (Stimulate) images This format is similar to a MetaImageIO file: The user should specify the .spr file (not the data file : .sdt)
itk::StimulateImageIOFactoryCreate instances of StimulateImageIO objects using an object factory
itk::STLConstContainerAdaptor< TContainer >An adapter object that casts a [const itk::XxxContainer] into [const std::xxx] and enables access to the underlying data structure
itk::STLContainerAdaptor< TContainer >An adapter object that casts a itk::XxxContainer into std::xxx and enables access to the underlying data structure
itk::StochasticFractalDimensionImageFilter< TInputImage, TMaskImage, TOutputImage >This filter computes the stochastic fractal dimension of the input image
itk::StoppingCriterionBaseAn abstract base class to represent a stopping criterion for an iterative algorithm
itk::StreamingImageFilter< TInputImage, TOutputImage >Pipeline object to control data streaming for large data processing
itk::StreamingImageIOBaseA base class for specific ImageIO file formats which support streaming
itk::Testing::StretchIntensityImageFilter< TInputImage, TOutputImage >Applies a linear transformation to the intensity levels of the input Image
itk::StructHashFunction< TInput >Generic hash function for an arbitrary struct (or class)
itk::FlatStructuringElement< VDimension >::StructuringElementFacet< VDimension3 >
itk::Functor::Sub2< TInput1, TInput2, TOutput >
itk::Statistics::Subsample< TSample >This class stores a subset of instance identifiers from another sample object. You can create a subsample out of another sample object or another subsample object. The class is useful when storing or extracting a portion of a sample object. Note that when the elements of a subsample are sorted, the instance identifiers of the subsample are sorted without changing the original source sample. Most Statistics algorithms (that derive from StatisticsAlgorithmBase accept Subsample objects as inputs)
itk::SubtractConstantFromImageFilter< TInputImage, TConstant, TOutputImage >Add a constant to all input pixels
itk::SubtractImageFilter< TInputImage1, TInputImage2, TOutputImage >Pixel-wise subtraction of two images
itk::Functor::SumAccumulator< TInputPixel, TOuputPixel >
itk::Statistics::SumInputFunction< TMeasurementVector, ScalarType >This is the itkSumInputFunction class
itk::Functor::SumLabelObjectAccessor< TLabelObject >
itk::Function::SummerColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::SumOfSquaresImageFunction< TInputImage, TCoordRep >Calculate the sum of squares in the neighborhood of a pixel
itk::SumProjectionImageFilter< TInputImage, TOutputImage >Sum projection
itk::SurfaceSpatialObject< TDimension >Representation of a Surface based on the spatial object classes
itk::SurfaceSpatialObjectPoint< TPointDimension >Point used for a Surface definition
itk::SymmetricEigenAnalysis< TMatrix, TVector, TEigenMatrix >Find Eigen values of a real 2D symmetric matrix. It serves as a thread-safe alternative to the class: vnl_symmetric_eigensystem, which uses netlib routines
itk::Functor::SymmetricEigenAnalysisFunction< TInput, TOutput >
itk::SymmetricEigenAnalysisImageFilter< TInputImage, TOutputImage >Computes the eigen-values of every input symmetric matrix pixel
itk::SymmetricEigenSystem< TMatrixElement, VNumberOfRows >Wrapper of the vnl_symmetric_eigensystem algorithm
itk::SymmetricEllipsoidInteriorExteriorSpatialFunction< VDimension, TInput >Function implementation of an ellipsoid
itk::SymmetricForcesDemonsRegistrationFilter< TFixedImage, TMovingImage, TDisplacementField >Deformably register two images using the demons algorithm
itk::SymmetricForcesDemonsRegistrationFunction< TFixedImage, TMovingImage, TDisplacementField >
itk::SymmetricSecondRankTensor< TComponent, NDimension >Represent a symmetric tensor of second rank
itk::Statistics::SymmetricSigmoidTransferFunction< ScalarType >This is the itkSymmetricSigmoidTransferFunction class
itk::SyNImageRegistrationMethod< TFixedImage, TMovingImage, TTransform >Interface method for the performing greedy SyN image registration
itk::SysResourceMemoryUsageObserver
itk::Functor::Tan< TInput, TOutput >
itk::Statistics::TanHTransferFunction< ScalarType >This is the itkTanHTransferFunction class
itk::TanImageAdaptor< TImage, TOutputPixelType >Presents an image as being composed of the vcl_tan() of its pixels
itk::TanImageFilter< TInputImage, TOutputImage >Computes the tangent of each input pixel
itk::Accessor::TanPixelAccessor< TInternalType, TExternalType >Give access to the vcl_tan() function of a value
itk::Statistics::TanSigmoidTransferFunction< ScalarType >This is the itkTanSigmoidTransferFunction class
itk::Statistics::TDistributionTDistribution class defines the interface for a univariate Student-t distribution (pdfs, cdfs, etc.)
itk::TemporalDataObjectDataObject subclass with knowledge of temporal region
itk::TemporalProcessObjectTemporalProcessObject implements a ProcessObject for the itk pipeline with the notion of a temporal region
itk::TemporalRegionRegion subclass that holds a region in time
itk::Functor::TensorFractionalAnisotropyFunction< TInput >
itk::TensorFractionalAnisotropyImageFilter< TInputImage, TOutputImage >Computes the Fractional Anisotropy for every pixel of a input tensor image
itk::Functor::TensorRelativeAnisotropyFunction< TInput >
itk::TensorRelativeAnisotropyImageFilter< TInputImage, TOutputImage >Computes the Relative Anisotropy for every pixel of a input tensor image
itk::TernaryAddImageFilter< TInputImage1, TInputImage2, TInputImage3, TOutputImage >Pixel-wise addition of three images
itk::TernaryFunctorImageFilter< TInputImage1, TInputImage2, TInputImage3, TOutputImage, TFunction >Implements pixel-wise generic operation of three images
itk::TernaryMagnitudeImageFilter< TInputImage1, TInputImage2, TInputImage3, TOutputImage >Pixel-wise addition of three images
itk::TernaryMagnitudeSquaredImageFilter< TInputImage1, TInputImage2, TInputImage3, TOutputImage >Pixel-wise addition of three images
itk::TetrahedronCell< TCellInterface >TetrahedronCell represents a tetrahedron for a Mesh
itk::TetrahedronCellTopologyTetrahedronCellTopology holds data defining the topological connections of the vertices and edges of a TetrahedronCell
itk::TextOutput
itk::ThinPlateR2LogRSplineKernelTransform< TScalarType, NDimensions >
itk::ThinPlateSplineKernelTransform< TScalarType, NDimensions >
itk::ParallelSparseFieldLevelSetImageFilter< TInputImage, TOutputImage >::ThreadData
itk::ThreadedDomainPartitioner< TDomain >Virtual base class for partitioning a domain into subsets to be processed per thread when parallel processing
itk::ThreadedImageRegionPartitioner< VDimension >Class for partitioning of an ImageRegion
itk::ThreadedIndexedContainerPartitioner
ThreadedIndexedContainerPartitionerPartitions an indexed container
itk::ThreadedIteratorRangePartitioner< TIterator >Partitions an iterator range for threading
itk::ThreadedIteratorRangePartitionerDomain< TIterator >Domain type for the ThreadedIteratorRangePartitioner
itk::ThreadLoggerProviding logging service as a separate thread
itk::NarrowBandImageFilterBase< TInputImage, TOutputImage >::ThreadRegionType
itk::FiniteDifferenceSparseImageFilter< TInputImageType, TSparseOutputImageType >::ThreadRegionType
itk::MatchCardinalityImageToImageMetric< TFixedImage, TMovingImage >::ThreadStruct
itk::ImageSource< TOutputImage >::ThreadStruct
itk::ImageTransformer< TInputImage >::ThreadStruct
itk::VideoSource< TOutputVideoStream >::ThreadStruct
itk::DomainThreader< TDomainPartitioner, TAssociate >::ThreadStruct
itk::ThresholdImageFilter< TImage >Set image values to a user-specified value if they are below, above, or between simple threshold values
itk::Functor::ThresholdLabeler< TInput, TOutput >
itk::ThresholdLabelerImageFilter< TInputImage, TOutputImage >Label an input image according to a set of thresholds
itk::ThresholdMaximumConnectedComponentsImageFilter< TInputImage, TOutputImage >Finds the threshold value of an image based on maximizing the number of objects in the image that are larger than a given minimal size
itk::ThresholdSegmentationLevelSetFunction< TImageType, TFeatureImageType >This function is used in ThresholdSegmentationLevelSetImageFilter to segment structures in images based on intensity values
itk::ThresholdSegmentationLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on intensity values
itk::TIFFImageIOImageIO object for reading and writing TIFF images
itk::TIFFImageIOFactoryCreate instances of TIFFImageIO objects using an object factory
itk::Functor::TikhonovDeconvolutionFunctor< TInput1, TInput2, TOutput >
itk::TikhonovDeconvolutionImageFilter< TInputImage, TKernelImage, TOutputImage, TInternalPrecision >An inverse deconvolution filter regularized in the Tikhonov sense
itk::TileImageFilter< TInputImage, TOutputImage >Tile multiple input images into a single output image
itk::TileImageFilter< TInputImage, TOutputImage >::TileInfo
itk::TimeProbeComputes the time passed between two points in code
itk::TimeProbesCollectorBaseAggregates a set of time probes
itk::TimeStampGenerate a unique, increasing time value
itk::TimeVaryingBSplineVelocityFieldImageRegistrationMethod< TFixedImage, TMovingImage, TTransform >Interface method for the current registration framework using the time varying velocity field transform
itk::TimeVaryingBSplineVelocityFieldTransform< TScalar, NDimensions >Integrate a time-varying velocity field represented by a B-spline control point lattice
itk::TimeVaryingBSplineVelocityFieldTransformParametersAdaptor< TTransform >TimeVaryingBSplineVelocityFieldTransformParametersAdaptor is a helper class intended to definition
itk::TimeVaryingVelocityFieldImageRegistrationMethodv4< TFixedImage, TMovingImage, TTransform >Interface method for the current registration framework using the time varying velocity field transform
itk::TimeVaryingVelocityFieldIntegrationImageFilter< TTimeVaryingVelocityField, TDisplacementField >Integrate a time-varying velocity field using 4th order Runge-Kutta
itk::TimeVaryingVelocityFieldTransform< TScalar, NDimensions >Transform objects based on integration of a time-varying velocity field
itk::TimeVaryingVelocityFieldTransformParametersAdaptor< TTransform >TimeVaryingVelocityFieldTransformParametersAdaptor is a helper class intended to definition
itk::TobogganImageFilter< TInputImage >Toboggan image segmentation The Toboggan segmentation takes a gradient magnitude image as input and produces an (over-)segmentation of the image based on connecting each pixel to a local minimum of gradient. It is roughly equivalent to a watershed segmentation of the lowest level
itk::TorusInteriorExteriorSpatialFunction< VDimension, TInput >Spatial function implementation of torus symmetric about the z-axis in 3D
itk::Statistics::TrainingFunctionBase< TSample, TTargetVector, ScalarType >This is the itkTrainingFunctionBase class
itk::Statistics::TransferFunctionBase< ScalarType >This is the itkTransferFunctionBase class
itk::Transform< TScalarType, NInputDimensions, NOutputDimensions >Transform points and vectors from an input space to an output space
itk::TransformBase
itk::TransformFactory< T >Create instances of Transforms
itk::TransformFactoryBaseCreate instances of Transforms
itk::TransformFileReaderTODO
itk::TransformFileWriterTODO
itk::TransformIOBaseAbstract superclass defining the Transform IO interface
itk::TransformIOFactoryCreate instances of TransformIO objects using an object factory
itk::TransformMeshFilter< TInputMesh, TOutputMesh, TTransform >TransformMeshFilter applies a transform to all the points of a mesh
itk::TransformParametersAdaptor< TTransform >Base helper class intended for multi-resolution image registration
itk::TransformParametersAdaptorBase< TTransform >Base helper class intended for multi-resolution image registration
itk::TransformToDisplacementFieldSource< TOutputImage, TTransformPrecisionType >Generate a displacement field from a coordinate transform
itk::TranslationTransform< TScalarType, NDimensions >Translation transformation of a vector space (e.g. space coordinates)
itk::TreeAddEvent< TTreeType >Checks if a node has been added to the tree
itk::TreeChangeEvent< TTreeType >Checks if the position of a node in the tree has been changed
itk::TreeContainer< TValueType >A tree container
itk::TreeContainerBase< TValueType >A base class for tree containers
itk::TreeIteratorBase< TTreeType >This class provides the base implementation for tree iterators
itk::TreeIteratorClone< TObjectType >
itk::TreeNode< TValueType >Represents a node in a tree
itk::TreeNodeChangeEvent< TTreeType >Signals that a node has been set to another value. The position of the changed node is provided
itk::TreePruneEvent< TTreeType >Signals that a node and all its childs will shortly be removed. The position of the top-level removed node is provided
itk::TreeRemoveEvent< TTreeType >Checks if a node has been removed from the tree
itk::TriangleCell< TCellInterface >
itk::TriangleCellTopology
itk::TriangleHelper< TPoint >A convenience class for computation of various triangle elements in 2D or 3D
itk::TriangleMeshToBinaryImageFilter< TInputMesh, TOutputImage >3D Rasterization algorithm Courtesy of Dr David Gobbi of Atamai Inc
itk::TriangleMeshToSimplexMeshFilter< TInputMesh, TOutputMesh >This filter converts a triangle mesh into a 2-simplex mesh
itk::TriangleThresholdCalculator< THistogram, TOutput >Computes the Triangle's threshold for an image
itk::TriangleThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the Triangle Threshold
itk::TubeSpatialObject< TDimension, TTubePointType >Representation of a tube based on the spatial object classes
itk::TubeSpatialObjectPoint< TPointDimension >Point used for a tube definition
itk::Statistics::TwoHiddenLayerBackPropagationNeuralNetwork< TMeasurementVector, TTargetVector >This is the itkTwoHiddenLayerBackPropagationNeuralNetwork class
itk::TwoOutputExampleImageFilter< TImage >Example of a filter that produce two outputs
itk::TxtTransformIOFactoryCreate instances of TxtTransformIO objects using an object factory
itk::UnaryCorrespondenceMatrix< TItemType >A matrix used to store the Unary Metric for medial node comparisons between two images
itk::UnaryFunctorImageFilter< TInputImage, TOutputImage, TFunction >Implements pixel-wise generic operation on one image
itk::UnconstrainedRegionBasedLevelSetFunctionSharedData< TInputImage, TFeatureImage, TSingleData >Helper class used to share data in the ScalarChanAndVeseLevelSetFunction
itk::Concept::Detail::UniqueType< T >
itk::Concept::Detail::UniqueType_bool< bool >
itk::Concept::Detail::UniqueType_int< int >
itk::Concept::Detail::UniqueType_unsigned_int< int >
itk::ImageIOBase::UnknownType
itk::MeshIOBase::UnknownType
itk::UnsharpMaskLevelSetImageFilter< TInputImage, TOutputImage >This class implements a detail enhancing filter by making use of the 4th-order level set isotropic diffusion (smoothing) PDE
itk::ImageToImageFilterDetail::UnsignedIntDispatch< int >Templated class to produce a unique type for each unsigned integer (usually a dimension)
itk::UpdateMalcolmSparseLevelSet< VDimension, TEquationContainer >Base class for updating the Malcolm representation of level-set function
itk::UpdateShiSparseLevelSet< VDimension, TEquationContainer >Base class for updating the Shi representation of level-set function
itk::UpdateWhitakerSparseLevelSet< VDimension, TLevelSetValueType, TEquationContainer >Base class for updating the level-set function
itk::UserEvent
itk::ValarrayImageContainer< TElementIdentifier, TElement >Defines a front-end to the std\::<valarray> container that conforms to the ImageContainerInterface
itk::ValuedRegionalExtremaImageFilter< TInputImage, TOutputImage, TFunction1, TFunction2 >Uses a flooding algorithm to set all voxels that are not a regional extrema to the max or min of the pixel type
itk::ValuedRegionalMaximaImageFilter< TInputImage, TOutputImage >Transforms the image so that any pixel that is not a regional maxima is set to the minimum value for the pixel type. Pixels that are regional maxima retain their value
itk::ValuedRegionalMinimaImageFilter< TInputImage, TOutputImage >Transforms the image so that any pixel that is not a regional minima is set to the maximum value for the pixel type. Pixels that are regional minima retain their value
itk::VanHerkGilWermanDilateImageFilter< TImage, TKernel >
itk::VanHerkGilWermanErodeDilateImageFilter< TImage, TKernel, TFunction1 >Class to implement erosions and dilations using anchor methods. This is the base class that must be instantiated with appropriate definitions of greater, less and so on. The SetBoundary facility isn't necessary for operation of the anchor method but is included for compatability with other morphology classes in itk
itk::VanHerkGilWermanErodeImageFilter< TImage, TKernel >
VanHerkGilWermanUtilitiesFunctionality in common for anchor openings/closings and erosions/dilation
itk::VariableLengthVector< TValueType >Represents an array whose length can be defined at run-time
itk::VariableSizeMatrix< T >A templated class holding a M x N size Matrix
itk::VarianceImageFunction< TInputImage, TCoordRep >Calculate the variance in the neighborhood of a pixel
itk::Functor::VarianceLabelObjectAccessor< TLabelObject >
itk::Vector< T, NVectorDimension >A templated class holding a n-Dimensional vector
itk::VectorAnisotropicDiffusionFunction< TImage >
itk::Functor::VectorCast< TInput, TOutput >
itk::VectorCastImageFilter< TInputImage, TOutputImage >Casts input vector pixels to output vector pixel type
itk::VectorCentralDifferenceImageFunction< TInputImage, TCoordRep >Calculate the derivative by central differencing
itk::VectorConfidenceConnectedImageFilter< TInputImage, TOutputImage >Segment pixels with similar statistics using connectivity
itk::VectorConnectedComponentImageFilter< TInputImage, TOutputImage, TMaskImage >A connected components filter that labels the objects in a vector image. Two vectors are pointing similar directions if one minus their dot product is less than a threshold. Vectors that are 180 degrees out of phase are similar. Assumes that vectors are normalized
itk::VectorContainer< TElementIdentifier, TElement >Define a front-end to the STL "vector" container that conforms to the IndexedContainerInterface
itk::Statistics::VectorContainerToListSampleAdaptor< TVectorContainer >This class provides ListSample interface to ITK VectorContainer
itk::VectorCurvatureAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >
itk::VectorCurvatureNDAnisotropicDiffusionFunction< TImage >
itk::VectorExpandImageFilter< TInputImage, TOutputImage >Expand the size of a vector image by an integer factor in each dimension
itk::VectorGradientAnisotropicDiffusionImageFilter< TInputImage, TOutputImage >
itk::VectorGradientMagnitudeImageFilter< TInputImage, TRealType, TOutputImage >Computes a scalar, gradient magnitude image from a multiple channel (pixels are vectors) input
itk::VectorGradientNDAnisotropicDiffusionFunction< TImage >
itk::VectorImage< TPixel, VImageDimension >Templated n-dimensional vector image class
itk::VectorImageNeighborhoodAccessorFunctor< TImage >Provides accessor interfaces to Access pixels and is meant to be used on pointers to pixels held by the Neighborhood class
itk::VectorImageToImageAdaptor< TPixelType, Dimension >Presents a VectorImage and extracts a component from it into an image
itk::Accessor::VectorImageToImagePixelAccessor< TType >Extract components from a VectorImage
itk::Functor::VectorIndexSelectionCast< TInput, TOutput >
itk::VectorIndexSelectionCastImageFilter< TInputImage, TOutputImage >Extracts the selected index of the vector that is the input pixel type
itk::VectorInterpolateImageFunction< TInputImage, TCoordRep >Base class for all vector image interpolaters
itk::VectorLinearInterpolateImageFunction< TInputImage, TCoordRep >Linearly interpolate a vector image at specified positions
itk::VectorLinearInterpolateNearestNeighborExtrapolateImageFunction< TInputImage, TCoordRep >Linearly interpolate or NN extrapolate a vector image at specified positions
itk::Functor::VectorMagnitude< TInput, TOutput >
itk::VectorMagnitudeImageFilter< TInputImage, TOutputImage >Take an image of vectors as input and produce an image with the magnitude of those vectors
itk::Functor::VectorMagnitudeLinearTransform< TInput, TOutput >
itk::VectorMeanImageFunction< TInputImage, TCoordRep >Calculate the mean value in the neighborhood of a pixel in a Vector image
itk::Function::VectorMorphologicalGradientHistogram< TInputPixel >
itk::Function::VectorMorphologyHistogram< TInputPixel, TCompare >
itk::VectorNearestNeighborInterpolateImageFunction< TInputImage, TCoordRep >Nearest neighbor interpolate a vector image at specified positions
itk::VectorNeighborhoodInnerProduct< TImage >Defines the inner product operation between an itk::Neighborhood and an itk::NeighborhoodOperator
itk::VectorNeighborhoodOperatorImageFilter< TInputImage, TOutputImage >Applies a single scalar NeighborhoodOperator to an itk::Vector image region
itk::Function::VectorRankHistogram< TInputPixel >
itk::VectorResampleImageFilter< TInputImage, TOutputImage, TInterpolatorPrecisionType >Resample an image via a coordinate transform
itk::VectorRescaleIntensityImageFilter< TInputImage, TOutputImage >Applies a linear transformation to the magnitude of pixel vectors in a vector Image
itk::VectorThresholdSegmentationLevelSetFunction< TImageType, TFeatureImageType >This function is used in VectorThresholdSegmentationLevelSetImageFilter to segment structures in images based on the Mahalanobis distance
itk::VectorThresholdSegmentationLevelSetImageFilter< TInputImage, TFeatureImage, TOutputPixelType >Segments structures in images based on intensity values
itk::VectorToRGBImageAdaptor< TImage >Presents an image of pixel type Vector as being and image of RGBPixel type
itk::Accessor::VectorToRGBPixelAccessor< T >Give access to a Vector pixel type as if it were a RGBPixel type
itk::VersionTrack the current version of the software
itk::Versor< T >A templated class holding a unit quaternion
itk::VersorRigid3DTransform< TScalarType >VersorRigid3DTransform of a vector space (e.g. space coordinates)
itk::VersorRigid3DTransformOptimizerImplement a gradient descent optimizer for the VersorRigid3DTransform parameter space
itk::VersorTransform< TScalarType >
itk::VersorTransformOptimizerImplement a gradient descent optimizer
itk::VertexCell< TCellInterface >Represents a single vertex for a Mesh
itk::ContourExtractor2DImageFilter< TInputImage >::VertexHash
itk::VesselTubeSpatialObject< TDimension >Representation of a tube based on the spatial object classes
itk::VesselTubeSpatialObjectPoint< TPointDimension >Point used for a tube definition
itk::VideoFileReader< TOutputVideoStream >Reader that creates a VideoStream
itk::VideoFileWriter< TInputVideoStream >Writer that takes in a VideoStream and writes the frames to a file
itk::VideoIOBaseAbstract superclass defines video IO interface
itk::VideoIOFactoryCreate instances of VideoIO objects using an object factory
itk::VideoSource< TOutputVideoStream >A TemporalProcessObject that produces a VideoStream
itk::VideoStream< TFrameType >A DataObject that holds a buffered portion of a video
itk::VideoToVideoFilter< TInputVideoStream, TOutputVideoStream >Base class for filters that use a VideoStream as input and output
itk::VMMapData_10_2TODO
itk::VMMapFileParser< TVMMapDataType >Read the output of a vmmap command and extract the memory usage information. Used for MAC OS X machines
itk::VMMapRecordContains an entry in a smaps file
itk::VMMapSummaryRecordContains an entry in a smaps file
vnl_matrix
vnl_vector
itk::VnlFFTCommonCommon routines related to Vnl's FFT implementation
itk::VnlFFTCommon::VnlFFTTransform< TImage >
itk::VnlForwardFFTImageFilter< TInputImage, TOutputImage >VNL based forward Fast Fourier Transform
itk::VnlHalfHermitianToRealInverseFFTImageFilter< TInputImage, TOutputImage >VNL-based reverse Fast Fourier Transform
itk::VnlInverseFFTImageFilter< TInputImage, TOutputImage >VNL-based reverse Fast Fourier Transform
VNLIterativeSparseSolverTraits< T >
itk::VnlRealToHalfHermitianForwardFFTImageFilter< TInputImage, TOutputImage >VNL-based forward Fast Fourier Transform
itk::VolumeSplineKernelTransform< TScalarType, NDimensions >
itk::VoronoiDiagram2D< TCoordType >Implements the 2-Dimensional Voronoi Diagram
itk::VoronoiDiagram2DGenerator< TCoordType >Implement the Sweep Line Algorithm for the construction of the 2D Voronoi Diagram
itk::VoronoiDiagram2D< TCoordType >::VoronoiEdge
itk::VoronoiPartitioningImageFilter< TInputImage, TOutputImage >
itk::VoronoiSegmentationImageFilter< TInputImage, TOutputImage, TBinaryPriorImage >
itk::VoronoiSegmentationImageFilterBase< TInputImage, TOutputImage, TBinaryPriorImage >Base class for VoronoiSegmentationImageFilter
itk::VoronoiSegmentationRGBImageFilter< TInputImage, TOutputImage >
itk::VotingBinaryHoleFillingImageFilter< TInputImage, TOutputImage >Fills in holes and cavities by applying a voting operation on each pixel
itk::VotingBinaryImageFilter< TInputImage, TOutputImage >Applies a voting operation in a neighborhood of each pixel
itk::VotingBinaryIterativeHoleFillingImageFilter< TImage >Fills in holes and cavities by iteratively applying a voting operation
itk::VoxBoCUBImageIORead VoxBoCUBImage file format
itk::VoxBoCUBImageIOFactoryCreate instances of VoxBoCUBImageIO objects using an object factory
itk::VTKImageExport< TInputImage >Connect the end of an ITK image pipeline to a VTK pipeline
itk::VTKImageExportBaseSuperclass for VTKImageExport instantiations
itk::VTKImageImport< TOutputImage >Connect the end of an VTK pipeline to an ITK image pipeline
itk::VTKImageIOImageIO class for reading VTK images
itk::VTKImageIOFactoryCreate instances of VTKImageIO objects using an object factory
itk::VTKPolyDataMeshIOThis class defines how to read and write vtk legacy file format
itk::VTKPolyDataMeshIOFactoryCreate instances of VTKPolyDataMeshIO objects using an object factory
itk::VTKPolyDataReader< TOutputMesh >Reads a vtkPolyData file and create an itkMesh
itk::VTKPolyDataWriter< TInputMesh >Writes an itkMesh to a file in VTK file format
itk::WarpHarmonicEnergyCalculator< TInputImage >Compute the harmonic energy of a deformation field
itk::WarpImageFilter< TInputImage, TOutputImage, TDisplacementField >Warps an image using an input displacement field
itk::WarpMeshFilter< TInputMesh, TOutputMesh, TDisplacementField >WarpMeshFilter applies a deformation field to all the points of a mesh. The deformation field is represented as an image of Vectors
itk::WarpVectorImageFilter< TInputImage, TOutputImage, TDisplacementField >Warps an image using an input displacement field
itk::WatershedImageFilter< TInputImage >A low-level image analysis algorithm that automatically produces a hierarchy of segmented, labeled images from a scalar-valued image input
itk::WatershedMiniPipelineProgressCommand
itk::WeakPointer< TObjectType >Implements a weak reference to an object
itk::Functor::WeightedAdd2< TInput1, TInput2, TOutput >
itk::WeightedAddImageFilter< TInputImage1, TInputImage2, TOutputImage >Computes a weighted sum of two images pixel-wise
itk::Statistics::WeightedCentroidKdTreeGenerator< TSample >This class generates a KdTree object with centroid information
itk::Statistics::WeightedCovarianceSampleFilter< TSample >Calculates the covariance matrix of the target sample data. where each measurement vector has an associated weight value
itk::Functor::WeightedElongationLabelObjectAccessor< TLabelObject >
itk::Functor::WeightedFlatnessLabelObjectAccessor< TLabelObject >
itk::Statistics::WeightedMeanSampleFilter< TSample >Given a sample where each measurement vector has associated weight value, this filter computes the sample mean
itk::Functor::WeightedPrincipalAxesLabelObjectAccessor< TLabelObject >
itk::Functor::WeightedPrincipalMomentsLabelObjectAccessor< TLabelObject >
itk::Statistics::WeightSetBase< TMeasurementVector, TTargetVector >This is the itkWeightSetBase class
itk::Function::WelchWindowFunction< VRadius, TInput, TOutput >Window function for sinc interpolation.

\[ w(x) = 1 - ( \frac{x^2}{m^2} ) \]

itk::WhitakerSparseLevelSetImage< TOutput, VDimension >Derived class for the sparse-field representation of level-set function
itk::WhiteTopHatImageFilter< TInputImage, TOutputImage, TKernel >White top hat extract local maxima that are larger than the structuring element
itk::Functor::WienerDeconvolutionFunctor< TPixel >
itk::WienerDeconvolutionImageFilter< TInputImage, TKernelImage, TOutputImage, TInternalPrecision >The Wiener deconvolution image filter is designed to restore an image convolved with a blurring kernel while keeping noise enhancement to a minimum
itk::Function::WindowConvergenceMonitoringFunction< TScalar >Class which monitors convergence during the course of optimization
itk::WindowedSincInterpolateImageFunction< TInputImage, VRadius, TWindowFunction, TBoundaryCondition, TCoordRep >Use the windowed sinc function to interpolate
itk::Function::WinterColormapFunction< TScalar, TRGBPixel >Function object which maps a scalar value into an RGB colormap value
itk::WisdomFilenameGeneratorBase
itk::WrapPadImageFilter< TInputImage, TOutputImage >Increase the image size by padding with replicants of the input image value
itk::XMLFileOutputWindowMessages sent from the system are sent to a file with each message enclosed by XML tags
itk::XMLFilterWatcherSimple mechanism for monitoring the pipeline events of a filter and reporting these events to std::cout. Formats reports with xml
itk::XMLReader< T >Template base class for an XMLReader It's purpose really is just to define the simple interface for extracting the object resulting from reading the XML File. Since it doesn't define any of the pure virtual methods in XMLReaderBase, It can't be instantiated by itself
itk::XMLReaderBase
itk::XMLWriterBase< T >
itk::Functor::XOR< TInput1, TInput2, TOutput >
itk::XorImageFilter< TInputImage1, TInputImage2, TOutputImage >Computes the XOR logical operator pixel-wise between two images
itk::YenThresholdCalculator< THistogram, TOutput >Computes the Yen's threshold for an image
itk::YenThresholdImageFilter< TInputImage, TOutputImage, TMaskImage >Threshold an image using the Yen Threshold
itk::ZeroCrossingBasedEdgeDetectionImageFilter< TInputImage, TOutputImage >This filter implements a zero-crossing based edge detecor
itk::ZeroCrossingImageFilter< TInputImage, TOutputImage >This filter finds the closest pixel to the zero-crossings (sign changes) in a signed itk::Image
itk::ZeroFluxNeumannBoundaryCondition< TInputImage, TOutputImage >A function object that determines a neighborhood of values at an image boundary according to a Neumann boundary condition where first, upwind derivatives on the boundary are zero. This is a useful condition in solving some classes of differential equations
itk::ZeroFluxNeumannPadImageFilter< TInputImage, TOutputImage >Increase the image size by padding according to the zero-flux Neumann boundary condition