go home Home | Main Page | Modules | Namespace List | Class Hierarchy | Alphabetical List | Data Structures | File List | Namespace Members | Data Fields | Globals | Related Pages
Namespaces | Data Structures | Functions
itk Namespace Reference

Namespaces

namespace  Statistics

Data Structures

class  AdaptiveStochasticGradientDescentOptimizer
 This class implements a gradient descent optimizer with adaptive gain. More...
class  AdvancedBSplineDeformableTransform
 Deformable transform using a B-spline representation. More...
class  AdvancedBSplineDeformableTransformBase
 Base class for deformable transform using a B-spline representation. More...
class  AdvancedCombinationTransform
 This class combines two transforms: an 'initial transform' with a 'current transform'. More...
class  AdvancedEuler3DTransform
 AdvancedEuler3DTransform of a vector space (e.g. space coordinates) More...
class  AdvancedIdentityTransform
 Implementation of an Identity Transform. More...
class  AdvancedImageToImageMetric
 An extension of the ITK ImageToImageMetric. It is the intended base class for all elastix metrics. More...
class  AdvancedKappaStatisticImageToImageMetric
 Computes similarity between two objects to be registered. More...
class  AdvancedMatrixOffsetTransformBase
class  AdvancedMeanSquaresImageToImageMetric
 Compute Mean square difference between two images, based on AdvancedImageToImageMetric... More...
class  AdvancedNormalizedCorrelationImageToImageMetric
 Computes normalized correlation between two images, based on AdvancedImageToImageMetric... More...
class  AdvancedRayCastInterpolateImageFunction
 Projective interpolation of an image at specified positions. More...
class  AdvancedRigid2DTransform
 AdvancedRigid2DTransform of a vector space (e.g. space coordinates) More...
class  AdvancedRigid3DTransform
 AdvancedRigid3DTransform of a vector space (e.g. space coordinates) More...
class  AdvancedSimilarity2DTransform
 AdvancedSimilarity2DTransform of a vector space (e.g. space coordinates) More...
class  AdvancedSimilarity3DTransform
 AdvancedSimilarity3DTransform of a vector space (e.g. space coordinates) More...
class  AdvancedTransform
 Transform maps points, vectors and covariant vectors from an input space to an output space. More...
class  AdvancedTranslationTransform
 Translation transformation of a vector space (e.g. space coordinates) More...
class  AdvancedVersorRigid3DTransform
 AdvancedVersorRigid3DTransform of a vector space (e.g. space coordinates) More...
class  AdvancedVersorTransform
class  AffineDTI3DTransform
 AffineDTI3DTransform of a vector space (e.g. space coordinates) More...
class  ANNbdTree
class  ANNBinaryTreeCreator
class  ANNBruteForceTree
class  ANNFixedRadiusTreeSearch
class  ANNkDTree
class  ANNPriorityTreeSearch
class  ANNStandardTreeSearch
class  BinaryANNTreeBase
class  BinaryANNTreeSearchBase
class  BinaryTreeBase
class  BinaryTreeSearchBase
class  BSplineDerivativeKernelFunction2
 Derivative of a B-spline kernel used for density estimation and nonparametric regression. More...
class  BSplineInterpolationDerivativeWeightFunction
 Returns the weights over the support region used for B-spline interpolation/reconstruction. More...
class  BSplineInterpolationSecondOrderDerivativeWeightFunction
 Returns the weights over the support region used for B-spline interpolation/reconstruction. More...
class  BSplineInterpolationWeightFunction2
 Returns the weights over the support region used for B-spline interpolation/reconstruction. More...
class  BSplineInterpolationWeightFunctionBase
 Returns the weights over the support region used for B-spline interpolation/reconstruction. More...
class  BSplineKernelFunction2
 B-spline kernel used for density estimation and nonparameteric regression. More...
class  BSplineSecondOrderDerivativeKernelFunction2
 Derivative of a B-spline kernel used for density estimation and nonparametric regression. More...
class  CenteredTransformInitializer2
 CenteredTransformInitializer2 is a helper class intended to initialize the center of rotation and the translation of Transforms having the center of rotation among their parameters. More...
class  CMAEvolutionStrategyOptimizer
 A Covariance Matrix Adaptation Evolution Strategy Optimizer. More...
class  CombinationImageToImageMetric
 Combines multiple metrics. More...
class  CorrespondingPointsEuclideanDistancePointMetric
 Computes the Euclidean distance between a moving point-set and a fixed point-set. Correspondence is needed. More...
class  CyclicBSplineDeformableTransform
 Deformable transform using a B-spline representation in which the B-spline grid is formulated in a cyclic way. More...
class  CyclicGridScheduleComputer
 This class computes all information about the B-spline grid. More...
class  DeformationFieldInterpolatingTransform
 Transform that interpolates a given deformation field. More...
class  DeformationFieldRegulizer
 This class combines any itk transform with the DeformationFieldTransform. More...
class  DeformationVectorFieldTransform
 An itk transform based on a DeformationVectorField. More...
class  DisplacementMagnitudePenaltyTerm
 A cost function that calculates $||T(x)-x||^2$. More...
class  ElasticBodyReciprocalSplineKernelTransform2
class  ElasticBodySplineKernelTransform2
class  ErodeMaskImageFilter
class  ExponentialLimiterFunction
 A soft limiter. More...
class  FiniteDifferenceGradientDescentOptimizer
 An optimizer based on gradient descent ... More...
class  FullSearchOptimizer
 An optimizer based on full search. More...
class  GenericConjugateGradientOptimizer
 A set of conjugate gradient algorithms. More...
class  GetConstNumberOfWeightsHack
class  GetConstNumberOfWeightsHack< SplineOrder, 0 >
class  GradientDescentOptimizer2
 Implement a gradient descent optimizer. More...
class  GradientDifferenceImageToImageMetric
 Computes similarity between two objects to be registered. More...
class  GridScheduleComputer
 This class computes all information about the B-spline grid, given the image information and the desired grid spacing. More...
class  HardLimiterFunction
 A hard limiter. More...
class  ImageFileCastWriter
 Casts pixel type and writes image data. More...
class  ImageFullSampler
 Samples all voxels in the InputImageRegion. More...
class  ImageGridSampler
 Samples image voxels on a regular grid. More...
class  ImageMaskSpatialObject2
 Implementation of an image mask as spatial object. More...
class  ImageRandomCoordinateSampler
 Samples an image by randomly composing a set of physical coordinates. More...
class  ImageRandomSampler
 Samples randomly some voxels of an image. More...
class  ImageRandomSamplerBase
 This class is a base class for any image sampler that randomly picks samples. More...
class  ImageRandomSamplerSparseMask
 Samples randomly some voxels of an image. More...
class  ImageSample
 A class that defines an image sample, which is the coordinates of a point and its value. More...
class  ImageSamplerBase
 This class is a base class for any image sampler. More...
class  ImageSpatialObject2
 Implementation of an image as spatial object. More...
class  ImageToImageMetricWithFeatures
 Computes similarity between regions of two images. More...
class  ImageToVectorContainerFilter
 Base class that takes in an image and pops out a vector container. More...
class  itkCUDAResampleImageFilter
 Resample an image on the GPU via a coordinate transform. More...
class  KernelTransform2
class  KNNGraphAlphaMutualInformationImageToImageMetric
 Computes similarity between two images to be registered. More...
class  LimiterFunctionBase
 Base class for all ITK limiter function objects. More...
class  LineSearchOptimizer
 A base class for LineSearch optimizers. More...
class  MeshFileReaderBase
 Base class for mesh readers. More...
class  MeshFileReaderException
 Base exception class for IO conflicts. More...
class  MevisDicomTiffImageIO
class  MevisDicomTiffImageIOFactory
 Create instances of MevisDicomTiffImageIO objects using an object factory. More...
class  MoreThuenteLineSearchOptimizer
 ITK version of the MoreThuente line search algorithm. More...
class  MultiInputImageRandomCoordinateSampler
 Samples an image by randomly composing a set of physical coordinates. More...
class  MultiInputImageToImageMetricBase
 Implements a metric base class that takes multiple inputs. More...
class  MultiInputMultiResolutionImageRegistrationMethodBase
 Base class for multi-resolution image registration methods. More...
class  MultiMetricMultiResolutionImageRegistrationMethod
 Base class for multi-resolution image registration methods. More...
class  MultiOrderBSplineDecompositionImageFilter
 Calculates the B-Spline coefficients of an image. Spline order may be per dimension from 0 to 5 per. More...
class  MultiResolutionGaussianSmoothingPyramidImageFilter
 Framework for creating images in a multi-resolution pyramid. More...
class  MultiResolutionImageRegistrationMethod2
 Base class for multi-resolution image registration methods. More...
class  MultiResolutionImageRegistrationMethodWithFeatures
 Class for multi-resolution image registration methods. More...
class  MultiResolutionShrinkPyramidImageFilter
 Framework for creating images in a multi-resolution pyramid. More...
class  NDImageBase
 An image whose dimension can be specified at runtime. More...
class  NDImageTemplate
 This class is a specialization of the NDImageBase, which acts as a wrap around an itk::Image. More...
class  NormalizedGradientCorrelationImageToImageMetric
 An metric based on the itk::NormalizedGradientCorrelationImageToImageMetric. More...
class  ParabolicErodeDilateImageFilter
 Parent class for morphological operations with parabolic structuring elements. More...
class  ParabolicErodeImageFilter
 Class for morphological erosion operations with parabolic structuring elements. More...
class  ParameterFileParser
 Implements functionality to read a parameter file. More...
class  ParameterMapInterface
 Implements functionality to get parameters from a parameter map. More...
class  ParzenWindowHistogramImageToImageMetric
 A base class for image metrics based on a joint histogram computed using Parzen Windowing. More...
class  ParzenWindowMutualInformationImageToImageMetric
 Computes the mutual information between two images to be registered using the method of Mattes et al. More...
class  ParzenWindowNormalizedMutualInformationImageToImageMetric
 Computes the normalized mutual information between two images to be registered using a method based on Thevenaz&Unser [3]. More...
class  PatternIntensityImageToImageMetric
 Computes similarity between two objects to be registered. More...
class  QuasiNewtonLBFGSOptimizer
 ITK version of the lbfgs algorithm ... More...
class  ReducedDimensionBSplineInterpolateImageFunction
 Evaluates the B-Spline interpolation of an image. Spline order may be from 0 to 5. More...
class  RSGDEachParameterApartBaseOptimizer
 An optimizer based on gradient descent... More...
class  RSGDEachParameterApartOptimizer
 An optimizer based on gradient descent. More...
class  ScaledSingleValuedCostFunction
 A cost function that applies a scaling to another cost function. More...
class  ScaledSingleValuedNonLinearOptimizer
class  SingleValuedPointSetToPointSetMetric
 Computes similarity between two point sets. More...
class  StackTransform
 Implements stack of transforms: one for every last dimension index. More...
class  StandardGradientDescentOptimizer
 This class implements a gradient descent optimizer with a decaying gain. More...
class  ThinPlateR2LogRSplineKernelTransform2
class  ThinPlateSplineKernelTransform2
class  TransformBendingEnergyPenaltyTerm
 A cost function that calculates the bending energy of a transformation. More...
class  TransformixInputPointFileReader
 A reader that understands transformix input point files. More...
class  TransformPenaltyTerm
 A cost function that calculates a penalty term on a transformation. More...
class  TransformRigidityPenaltyTerm
 A cost function that calculates a rigidity penalty term. More...
class  TransformToDeterminantOfSpatialJacobianSource
 Generate the spatial Jacobian from a coordinate transform. More...
class  TransformToSpatialJacobianSource
 Generate the spatial Jacobian matrix from a coordinate transform. More...
class  TranslationTransformInitializer
 TranslationTransformInitializer is a helper class intended to initialize the translation of a TranslationTransforms. More...
class  UpsampleBSplineParametersFilter
 Convenience class for upsampling a B-spline coefficient image. More...
class  VarianceOverLastDimensionImageMetric
 Compute the sum of variances over the slowest varying dimension in the moving image. More...
class  VectorContainerSource
 A base class for creating an ImageToVectorContainerFilter. More...
class  VectorDataContainer
 Define a front-end to the STL "vector" container that conforms to the IndexedContainerInterface. More...
class  VectorMeanDiffusionImageFilter
 Applies an averaging filter to an image. More...
class  VolumeSplineKernelTransform2
class  WeightedCombinationTransform
 Implements a weighted linear combination of multiple transforms. More...

Functions

template<class LineBufferType , class RealType , bool doDilate>
void DoLine (LineBufferType &LineBuf, LineBufferType &tmpLineBuf, const RealType magnitude, const RealType m_Extreme)
template<class TInIter , class TOutIter , class RealType , class OutputPixelType , bool doDilate>
void doOneDimension (TInIter &inputIterator, TOutIter &outputIterator, ProgressReporter &progress, const long LineLength, const unsigned direction, const int m_MagnitudeSign, const bool m_UseImageSpacing, const RealType m_Extreme, const RealType image_scale, const RealType Sigma)

Detailed Description

This class is a modification of an ITK class. The original copyright message is pasted here, which includes also the version information:

This file is a slightly modified version of an ITK file. Original ITK copyright message:

Parts of the code were taken from an ITK file. Original ITK copyright message, just for reference:

This class is a slight modification of the original ITK class: MultiResolutionImageRegistrationMethod. The original copyright message is pasted here, which includes also the version information:

Includes for the Superclass. Includes for the kNN trees. Supported trees. Supported tree searchers. Include for the spatial derivatives.

Needed for the check of a B-spline transform. Needed for the filtering of the B-spline coefficients. Include stuff needed for the construction of the rigidity coefficient image.

Function Documentation

template<class LineBufferType , class RealType , bool doDilate>
void itk::DoLine ( LineBufferType &  LineBuf,
LineBufferType &  tmpLineBuf,
const RealType  magnitude,
const RealType  m_Extreme 
)

Definition at line 9 of file itkParabolicMorphUtils.h.

template<class TInIter , class TOutIter , class RealType , class OutputPixelType , bool doDilate>
void itk::doOneDimension ( TInIter &  inputIterator,
TOutIter &  outputIterator,
ProgressReporter &  progress,
const long  LineLength,
const unsigned  direction,
const int  m_MagnitudeSign,
const bool  m_UseImageSpacing,
const RealType  m_Extreme,
const RealType  image_scale,
const RealType  Sigma 
)

Definition at line 56 of file itkParabolicMorphUtils.h.



Generated on 21-03-2014 for elastix by doxygen 1.8.1.2 elastix logo