ITK
4.1.0
Insight Segmentation and Registration Toolkit
|
#include <itkFEMRegistrationFilter.h>
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.
The forces driving the problem may also be given by user-supplied landmarks. The corners of the image, in this example, are always pinned. This example is designed for 2D or 3D images. A rectilinear mesh is generated automatically given the correct element type (Quadrilateral or Hexahedral). Our specific Solver for this example uses trapezoidal time stepping. This is a method for solving a second-order PDE in time. The solution is penalized by the zeroth (mass matrix) and first derivatives (stiffness matrix) of the shape functions. There is an option to perform a line search on the energy after each iteration. Optimal parameter settings require experimentation. The following approach tends to work well : Choose the relative size of density to elasticity (e.g. Rho / E ~= 1.) such that the image deforms locally and slowly. This also affects the stability of the solution. Choose the time step to control the size of the deformation at each step. Choose enough iterations to allow the solution to converge (this may be automated).
To use this filter the user will at a minimum set the Fixed and Moving images. If the user does not specify a mesh using the SetInputFEMObject() then a mesh will be created automatically of the approriate type (2d=quads and 3d=hex). The user has significant control over the registration process including setting number of resolution levels, material properties, and the metric used to define correspondence between images.
Definition at line 118 of file itkFEMRegistrationFilter.h.
typedef SmartPointer<const Self> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ConstPointer |
Reimplemented from itk::ImageToImageFilter< TMovingImage, TFixedImage >.
Definition at line 124 of file itkFEMRegistrationFilter.h.
typedef double itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::CoordRepType |
Typedef support for the interpolation function
Definition at line 164 of file itkFEMRegistrationFilter.h.
typedef VectorLinearInterpolateImageFunction<FieldType, CoordRepType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::DefaultInterpolatorType |
Definition at line 168 of file itkFEMRegistrationFilter.h.
typedef itk::VectorExpandImageFilter<FieldType, FieldType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ExpanderType |
Definition at line 176 of file itkFEMRegistrationFilter.h.
typedef ExpanderType::ExpandFactorsType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ExpandFactorsType |
Definition at line 177 of file itkFEMRegistrationFilter.h.
typedef TFemObjectType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FEMObjectType |
Definition at line 134 of file itkFEMRegistrationFilter.h.
typedef itk::ImageRegionIteratorWithIndex<FieldType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FieldIterator |
Definition at line 159 of file itkFEMRegistrationFilter.h.
typedef FieldType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FieldPointer |
Definition at line 179 of file itkFEMRegistrationFilter.h.
typedef itk::Image<VectorType, itkGetStaticConstMacro(ImageDimension)> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FieldType |
Definition at line 153 of file itkFEMRegistrationFilter.h.
typedef TFixedImage itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FixedImageType |
Definition at line 133 of file itkFEMRegistrationFilter.h.
typedef double itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::Float |
Definition at line 148 of file itkFEMRegistrationFilter.h.
typedef itk::ImageRegionIteratorWithIndex<FloatImageType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FloatImageIterator |
Definition at line 158 of file itkFEMRegistrationFilter.h.
typedef Image<float, itkGetStaticConstMacro(ImageDimension)> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FloatImageType |
Definition at line 143 of file itkFEMRegistrationFilter.h.
typedef itk::ImageRegionIteratorWithIndex<FixedImageType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ImageIterator |
Definition at line 157 of file itkFEMRegistrationFilter.h.
typedef FiniteDifferenceFunctionLoad<MovingImageType, FixedImageType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ImageMetricLoadType |
Instantiate the load class with the correct image type.
Definition at line 183 of file itkFEMRegistrationFilter.h.
typedef FixedImageType::SizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ImageSizeType |
Definition at line 136 of file itkFEMRegistrationFilter.h.
typedef itk::fem::ImageToRectilinearFEMObjectFilter<TMovingImage> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ImageToMeshType |
Definition at line 174 of file itkFEMRegistrationFilter.h.
typedef itk::VectorIndexSelectionCastImageFilter<FieldType, FloatImageType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::IndexSelectCasterType |
Definition at line 161 of file itkFEMRegistrationFilter.h.
typedef InterpolationGridType::PointType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::InterpolationGridPointType |
Definition at line 172 of file itkFEMRegistrationFilter.h.
typedef InterpolationGridType::SizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::InterpolationGridSizeType |
Definition at line 171 of file itkFEMRegistrationFilter.h.
typedef itk::Image<Element::ConstPointer, ImageDimension> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::InterpolationGridType |
Definition at line 170 of file itkFEMRegistrationFilter.h.
typedef InterpolatorType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::InterpolatorPointer |
Definition at line 166 of file itkFEMRegistrationFilter.h.
typedef VectorInterpolateImageFunction<FieldType, CoordRepType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::InterpolatorType |
Definition at line 165 of file itkFEMRegistrationFilter.h.
typedef std::vector<typename LoadLandmark::Pointer> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::LandmarkArrayType |
Definition at line 151 of file itkFEMRegistrationFilter.h.
typedef LinearSystemWrapperItpack itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::LinearSystemSolverType |
Definition at line 144 of file itkFEMRegistrationFilter.h.
typedef Load::ArrayType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::LoadArray |
Definition at line 149 of file itkFEMRegistrationFilter.h.
typedef MaterialLinearElasticity itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::MaterialType |
Definition at line 156 of file itkFEMRegistrationFilter.h.
typedef PDEDeformableRegistrationFunction<FixedImageType, MovingImageType, FieldType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::MetricBaseType |
Definition at line 185 of file itkFEMRegistrationFilter.h.
typedef MetricBaseType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::MetricBaseTypePointer |
Definition at line 187 of file itkFEMRegistrationFilter.h.
typedef TMovingImage itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::MovingImageType |
Definition at line 130 of file itkFEMRegistrationFilter.h.
typedef FixedImageType::PixelType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::PixelType |
Definition at line 135 of file itkFEMRegistrationFilter.h.
typedef SmartPointer<Self> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::Pointer |
Reimplemented from itk::ImageToImageFilter< TMovingImage, TFixedImage >.
Definition at line 123 of file itkFEMRegistrationFilter.h.
typedef FixedImageType::PointType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::PointType |
Definition at line 137 of file itkFEMRegistrationFilter.h.
typedef FEMRegistrationFilter itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::Self |
Standard class typedefs.
Reimplemented from itk::ImageToImageFilter< TMovingImage, TFixedImage >.
Definition at line 121 of file itkFEMRegistrationFilter.h.
typedef SolverCrankNicolson<ImageDimension> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SolverType |
Definition at line 145 of file itkFEMRegistrationFilter.h.
typedef FixedArray< double, ImageDimension > itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::StandardDeviationsType |
Definition at line 188 of file itkFEMRegistrationFilter.h.
typedef ImageToImageFilter<TMovingImage, TFixedImage> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::Superclass |
Reimplemented from itk::ImageToImageFilter< TMovingImage, TFixedImage >.
Definition at line 122 of file itkFEMRegistrationFilter.h.
typedef itk::Vector<float, itkGetStaticConstMacro(ImageDimension)> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::VectorType |
Definition at line 152 of file itkFEMRegistrationFilter.h.
typedef itk::WarpImageFilter<MovingImageType, FixedImageType, FieldType> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::WarperType |
Definition at line 154 of file itkFEMRegistrationFilter.h.
enum itk::fem::FEMRegistrationFilter::Sign |
Definition at line 147 of file itkFEMRegistrationFilter.h.
itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FEMRegistrationFilter | ( | ) | [protected] |
itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::~FEMRegistrationFilter | ( | ) | [protected] |
itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FEMRegistrationFilter | ( | const Self & | ) | [private] |
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::AddLandmark | ( | PointType | source, |
PointType | target | ||
) |
Add a way to include landmarks
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ApplyImageLoads | ( | MovingImageType * | i1, |
FixedImageType * | i2 | ||
) | [protected] |
The image loads are entered into the solver.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ApplyLoads | ( | ImageSizeType | Isz, |
double * | spacing = NULL |
||
) | [protected] |
The non-image loads are entered into the solver.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ChooseMetric | ( | unsigned int | whichmetric | ) |
Select the matric used for image correspondence. The options are: 0=mean squares 1=cross correlation 2=mutual information 3=Demons
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ClearLandmarks | ( | ) |
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ComputeJacobian | ( | ) |
Compute the jacobian of the current deformation field.
virtual::itk::LightObject::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::CreateAnother | ( | void | ) | const [virtual] |
Create an object from an instance, potentially deferring to a factory. This method allows you to create an instance of an object that is exactly the same type as the referring object. This is useful in cases where an object has been cast back to a base class.
Reimplemented from itk::Object.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::CreateLinearSystemSolver | ( | ) | [protected] |
Builds the itpack linear system wrapper with appropriate parameters. Currently undefined
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::CreateMesh | ( | unsigned int | ElementsPerSide, |
SolverType * | solver | ||
) | [protected] |
This function generates a regular mesh of ElementsPerSide^D size
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::DeleteLandmark | ( | unsigned int | i | ) |
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::EnforceDiffeomorphism | ( | float | thresh, |
SolverType * | S, | ||
bool | onlywriteimages | ||
) |
We check the jacobian of the current deformation field. If it is < threshold, we begin diffeomorphism enforcement: 1) Warp the moving image. 2) Set the vector field to zero. 3) Set the warped moving image as the new moving image, resizing if necessary.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::EvaluateEnergy | ( | ) | [protected] |
Evaluates the image similarity energy by calling the image metric
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::EvaluateResidual | ( | SolverType * | mySolver, |
Float | t | ||
) | [protected] |
This is used to calculate residual error
FieldPointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ExpandVectorField | ( | ExpandFactorsType * | expandFactors, |
FieldType * | f | ||
) | [protected] |
Re-size the vector field (smaller to larger).
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::FindBracketingTriplet | ( | SolverType * | mySolver, |
Float * | a, | ||
Float * | b, | ||
Float * | c | ||
) | [protected] |
virtual Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetAlpha | ( | ) | [virtual] |
Get/Set Alpha for the trapezoidal rule. This is usually set to 1.0, which is the default value.
virtual bool itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetCreateMeshFromImage | ( | ) | [virtual] |
Get/Set if the FEM Mesh should be created from the image or is provided by the user.
FieldType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetDisplacementField | ( | void | ) | [inline] |
Outputs the FE deformation field interpolated over the entire image domain.
Definition at line 257 of file itkFEMRegistrationFilter.h.
virtual unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetDoLineSearchOnImageEnergy | ( | ) | [virtual] |
Get/Set the minimum energy between the current and next solution by linear search.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetElasticity | ( | unsigned int | which = 0 | ) | [inline] |
Gets the stiffness Matrix weight.
Definition at line 388 of file itkFEMRegistrationFilter.h.
virtual unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetEmployRegridding | ( | ) | [virtual] |
Get/Set the number of iterations before regridding is employed.
virtual Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetEnergyReductionFactor | ( | ) | [virtual] |
Get/Set the energy below which we decide the solution has converged.
FixedImageType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetFixedImage | ( | void | ) | [inline] |
Definition at line 214 of file itkFEMRegistrationFilter.h.
ImageSizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetImageSize | ( | ) | [inline] |
Return the size of the full size image.
Definition at line 461 of file itkFEMRegistrationFilter.h.
FEMObjectType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetInputFEMObject | ( | unsigned int | level = 0 | ) |
virtual InterpolatorType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetInterpolator | ( | ) | [virtual] |
Get a pointer to the interpolator function.
FloatImageType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetJacobianImage | ( | ) | [inline] |
Get the image that gives the jacobian of the deformation field.
Definition at line 251 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetLandmark | ( | unsigned int | i, |
PointType & | source, | ||
PointType & | target | ||
) |
virtual unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetLineSearchMaximumIterations | ( | ) | [virtual] |
Get/Set the line search maximum number of iterations. The default value is 100.
virtual const ImageMetricLoadType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetLoad | ( | ) | [protected, virtual] |
Get/Set the solver's current load.
virtual double itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetMaximumError | ( | ) | const [virtual] |
Set/Get the desired maximum error of the Guassian kernel approximate.
virtual unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetMaximumKernelWidth | ( | ) | const [virtual] |
Set/Get the desired limits of the Gaussian kernel width.
virtual unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetMaxLevel | ( | ) | [virtual] |
Get/Set the maximum number of levels for multi resolution
MetricBaseTypePointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetMetric | ( | ) | [inline] |
Get/Set the Metric used to define correspondence between images/
Definition at line 470 of file itkFEMRegistrationFilter.h.
FloatImageType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetMetricImage | ( | FieldType * | F | ) | [protected] |
Calculates the metric over the domain given the vector field.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetMetricType | ( | ) | [inline] |
Return the type of image metric used for the registration
Definition at line 493 of file itkFEMRegistrationFilter.h.
MovingImageType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetMovingImage | ( | void | ) | [inline] |
Get the Moving image. This image is dependent on the current resolution in a multi-resolution registration
Definition at line 200 of file itkFEMRegistrationFilter.h.
virtual const char* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetNameOfClass | ( | ) | const [virtual] |
Run-time type information (and related methods)
Reimplemented from itk::ImageToImageFilter< TMovingImage, TFixedImage >.
MovingImageType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetOriginalMovingImage | ( | ) | [inline] |
Get the original full resolution moving image.
Definition at line 206 of file itkFEMRegistrationFilter.h.
virtual const StandardDeviationsType& itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetStandardDeviations | ( | ) | [virtual] |
Get the Gaussian smoothing standard deviations use for smoothing the displacement field.
virtual Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetTimeStep | ( | ) | [virtual] |
Get/Set the time step. This it typically set to 1.0, which is the default value. It may be preferable to use Rho to control step sizes.
virtual bool itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetUseLandmarks | ( | ) | [virtual] |
Get/Set if landmarks are being used.
virtual bool itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetUseMassMatrix | ( | ) | [virtual] |
Get/Set Use of the mass matrix. This should be true.
virtual bool itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetUseNormalizedGradient | ( | ) | [virtual] |
Get/Set the use of normalized gradient values in the image metric during registration
FixedImageType* itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetWarpedImage | ( | ) | [inline] |
Get the reference image warped to the target image. Must first apply the warp using WarpImage()
Definition at line 242 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GetWidthOfMetricRegion | ( | unsigned int | which = 0 | ) | [inline] |
Definition at line 320 of file itkFEMRegistrationFilter.h.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::GoldenSection | ( | SolverType * | mySolver, |
Float | tol = 0.01 , |
||
unsigned int | MaxIters = 25 |
||
) | [protected] |
Finds the optimum value between the last two solutions and sets the current solution to that value. Uses Evaluate Residual
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::InitializeField | ( | ) | [private] |
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::InsertLandmark | ( | unsigned int | i, |
PointType | source, | ||
PointType | target | ||
) |
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::InterpolateVectorField | ( | SolverType * | S | ) | [protected] |
Interpolates the vector field over the domain. Our convention is to always keep the vector field at the scale of the original images.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::IterativeSolve | ( | SolverType * | S | ) |
The solution loop
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::MultiResSolve | ( | ) |
The solution loop for a simple multi-resolution strategy.
static Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::New | ( | ) | [static] |
Method for creation through the object factory.
Reimplemented from itk::Object.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::operator= | ( | const Self & | ) | [private] |
PushBackInput(), PushFronInput() in the public section force the input to be the type expected by an ImageToImageFilter. However, these methods end of "hiding" the versions from the superclass (ProcessObject) whose arguments are DataObjects. Here, we re-expose the versions from ProcessObject to avoid warnings about hiding methods from the superclass.
Reimplemented from itk::ImageToImageFilter< TMovingImage, TFixedImage >.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::PrintSelf | ( | std::ostream & | os, |
Indent | indent | ||
) | const [protected, virtual] |
Methods invoked by Print() to print information about the object including superclasses. Typically not called by the user (use Print() instead) but used in the hierarchical print process to combine the output of several classes.
Reimplemented from itk::ImageToImageFilter< TMovingImage, TFixedImage >.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::PrintVectorField | ( | unsigned int | modnum = 1000 | ) |
Print vector field for debugging
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::RunRegistration | ( | void | ) |
Call this to register two images.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SampleVectorFieldAtNodes | ( | SolverType * | S | ) | [protected] |
This is used for changing between mesh resolutions.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetAlpha | ( | Float | _arg | ) | [virtual] |
Get/Set Alpha for the trapezoidal rule. This is usually set to 1.0, which is the default value.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetCreateMeshFromImage | ( | bool | _arg | ) | [virtual] |
Get/Set if the FEM Mesh should be created from the image or is provided by the user.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetCreateMeshFromImageOff | ( | ) | [inline] |
Get/Set if the FEM Mesh should be created from the image or is provided by the user.
Definition at line 529 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetCreateMeshFromImageOn | ( | ) | [inline] |
Get/Set if the FEM Mesh should be created from the image or is provided by the user.
Definition at line 525 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetDescentDirectionMaximize | ( | ) | [inline] |
Image Metric maximizes energy
Definition at line 412 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetDescentDirectionMinimize | ( | ) | [inline] |
Image Metric minimizes energy
Definition at line 406 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetDisplacementField | ( | FieldType * | F | ) | [inline] |
Sets the FE deformation field.
Definition at line 263 of file itkFEMRegistrationFilter.h.
References itk::ImageBase< VImageDimension >::GetLargestPossibleRegion(), and itk::ImageRegion< VImageDimension >::GetSize().
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetDoLineSearchOnImageEnergy | ( | unsigned int | _arg | ) | [virtual] |
Get/Set the minimum energy between the current and next solution by linear search.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetElasticity | ( | Float | i, |
unsigned int | which = 0 |
||
) | [inline] |
Sets the stiffness Matrix weight.
Definition at line 382 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetElement | ( | Element::Pointer | e | ) | [inline] |
This function allows one to set the element and its material externally.
Definition at line 499 of file itkFEMRegistrationFilter.h.
References itk::Math::e.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetEmployRegridding | ( | unsigned int | _arg | ) | [virtual] |
Get/Set the number of iterations before regridding is employed.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetEnergyReductionFactor | ( | Float | _arg | ) | [virtual] |
Get/Set the energy below which we decide the solution has converged.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetFixedImage | ( | FixedImageType * | T | ) |
Get/Set the target (fixed) image.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetGamma | ( | Float | r, |
unsigned int | which = 0 |
||
) | [inline] |
Image similarity energy weight
Definition at line 400 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetInputFEMObject | ( | FEMObjectType * | F, |
unsigned int | level = 0 |
||
) |
Get/Set the finite element mesh for the registration. A seperate mesh will be returned for each level of the registration. If the user provides a mesh, one should be provided for each level.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetInterpolator | ( | InterpolatorType * | _arg | ) | [virtual] |
Set the interpolator function.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetLineSearchMaximumIterations | ( | unsigned int | _arg | ) | [virtual] |
Get/Set the line search maximum number of iterations. The default value is 100.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetLoad | ( | ImageMetricLoadType * | _arg | ) | [protected, virtual] |
Get/Set the solver's current load.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetMaterial | ( | MaterialType::Pointer | m | ) | [inline] |
This sets the pointer to the material.
Definition at line 505 of file itkFEMRegistrationFilter.h.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetMaximumError | ( | double | _arg | ) | [virtual] |
Set/Get the desired maximum error of the Guassian kernel approximate.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetMaximumIterations | ( | unsigned int | i, |
unsigned int | which | ||
) | [inline] |
Setting the maximum iterations stops the solution after i iterations regardless of energy.
i | number of elements |
which | determines the resolution of the solution process the call is applied to. |
Definition at line 329 of file itkFEMRegistrationFilter.h.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetMaximumKernelWidth | ( | unsigned int | _arg | ) | [virtual] |
Set/Get the desired limits of the Gaussian kernel width.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetMaxLevel | ( | unsigned int | level | ) |
Get/Set the maximum number of levels for multi resolution
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetMeshPixelsPerElementAtEachResolution | ( | unsigned int | i, |
unsigned int | which = 0 |
||
) | [inline] |
The FEM filter can generate its own mesh for 2 or 3 dimensions, if none is provided. The mesh is generated for quadrilaterals in 2D and hexahedra in 3D. This function sets the number of elements generated along each dimension at the resolution designated by "which". E.g. to generate 10 pixels per element in each dimension in the 1st resolution, use SetMeshResolution(10,0);.
Definition at line 296 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetMetric | ( | MetricBaseTypePointer | MP | ) | [inline] |
Definition at line 475 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetMovingImage | ( | MovingImageType * | R | ) |
Set the Moving image.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetNumberOfIntegrationPoints | ( | unsigned int | i, |
unsigned int | which = 0 |
||
) | [inline] |
This determines the number of integration points to use at each resolution. These integration points are used to generate the force. The actual number used will be i^d, where d is the number of parameters in the elements local domain.
Definition at line 305 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetRho | ( | Float | r, |
unsigned int | which = 0 |
||
) | [inline] |
Mass matrix weight
Definition at line 394 of file itkFEMRegistrationFilter.h.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetStandardDeviations | ( | StandardDeviationsType | _arg | ) | [virtual] |
Set the Gaussian smoothing standard deviations for the displacement field. The values are set with respect to pixel coordinates.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetStandardDeviations | ( | double | value | ) | [virtual] |
Set the Gaussian smoothing standard deviations for the displacement field. The values are set with respect to pixel coordinates.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetTimeStep | ( | Float | _arg | ) | [virtual] |
Get/Set the time step. This it typically set to 1.0, which is the default value. It may be preferable to use Rho to control step sizes.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetUseLandmarks | ( | bool | _arg | ) | [virtual] |
Get/Set if landmarks are being used.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetUseLandmarksOff | ( | ) | [inline] |
Get/Set if landmarks are being used.
Definition at line 356 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetUseLandmarksOn | ( | ) | [inline] |
Definition at line 362 of file itkFEMRegistrationFilter.h.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetUseMassMatrix | ( | bool | _arg | ) | [virtual] |
Get/Set Use of the mass matrix. This should be true.
virtual void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetUseNormalizedGradient | ( | bool | _arg | ) | [virtual] |
Get/Set the use of normalized gradient values in the image metric during registration
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetUseNormalizedGradientOff | ( | ) | [inline] |
Get/Set the use of normalized gradient values in the image metric during registration
Definition at line 432 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetUseNormalizedGradientOn | ( | ) | [inline] |
Definition at line 438 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SetWidthOfMetricRegion | ( | unsigned int | i, |
unsigned int | which = 0 |
||
) | [inline] |
The metric region allows one to compute the derivative (force) of the similarity metric using a region of size [i,i] in 2D and [i,i,i] in 3D.
i | number of elements |
which | determines the region at a given resolution of the solution process. |
Definition at line 315 of file itkFEMRegistrationFilter.h.
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::SmoothDisplacementField | ( | ) | [protected] |
Smooth the current displacement field
void itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::WarpImage | ( | const MovingImageType * | R | ) |
Applies the warp to the input image.
const unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::ImageDimension = FixedImageType::ImageDimension [static] |
Dimensionality of input and output data is assumed to be the same.
Definition at line 141 of file itkFEMRegistrationFilter.h.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Alpha [private] |
Definition at line 668 of file itkFEMRegistrationFilter.h.
bool itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_CreateMeshFromImage [private] |
Definition at line 673 of file itkFEMRegistrationFilter.h.
ImageSizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_CurrentImageScaling [private] |
Definition at line 682 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_CurrentLevel [private] |
Definition at line 647 of file itkFEMRegistrationFilter.h.
FixedImageType::SizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_CurrentLevelImageSize [private] |
Definition at line 649 of file itkFEMRegistrationFilter.h.
Sign itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_DescentDirection [private] |
Definition at line 675 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_DoLineSearchOnImageEnergy [private] |
Definition at line 637 of file itkFEMRegistrationFilter.h.
vnl_vector<Float> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_E [private] |
Definition at line 662 of file itkFEMRegistrationFilter.h.
Element::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Element [private] |
Definition at line 706 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_EmployRegridding [private] |
Definition at line 674 of file itkFEMRegistrationFilter.h.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Energy [private] |
Definition at line 665 of file itkFEMRegistrationFilter.h.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_EnergyReductionFactor [private] |
Definition at line 676 of file itkFEMRegistrationFilter.h.
FEMObjectType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_FEMObject [private] |
Definition at line 709 of file itkFEMRegistrationFilter.h.
FieldType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Field [private] |
Definition at line 685 of file itkFEMRegistrationFilter.h.
FieldType::RegionType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_FieldRegion [private] |
Definition at line 683 of file itkFEMRegistrationFilter.h.
FieldType::SizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_FieldSize [private] |
Definition at line 684 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_FileCount [private] |
Definition at line 646 of file itkFEMRegistrationFilter.h.
FixedImageType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_FixedImage [private] |
Definition at line 703 of file itkFEMRegistrationFilter.h.
FloatImageType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_FloatImage [private] |
Definition at line 696 of file itkFEMRegistrationFilter.h.
ImageSizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_FullImageSize [private] |
Definition at line 677 of file itkFEMRegistrationFilter.h.
vnl_vector<Float> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Gamma [private] |
Definition at line 664 of file itkFEMRegistrationFilter.h.
ImageSizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_ImageOrigin [private] |
Definition at line 678 of file itkFEMRegistrationFilter.h.
ImageSizeType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_ImageScaling [private] |
Gives the ratio of original image size to current image size - for dealing with multi-res.
Definition at line 681 of file itkFEMRegistrationFilter.h.
InterpolatorPointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Interpolator [private] |
Definition at line 712 of file itkFEMRegistrationFilter.h.
LandmarkArrayType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_LandmarkArray [private] |
Definition at line 711 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_LineSearchMaximumIterations [private] |
Definition at line 638 of file itkFEMRegistrationFilter.h.
ImageMetricLoadType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Load [private] |
Definition at line 689 of file itkFEMRegistrationFilter.h.
MaterialType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Material [private] |
Definition at line 707 of file itkFEMRegistrationFilter.h.
double itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_MaximumError [private] |
Maximum error for Gaussian operator approximation.
Definition at line 715 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_MaximumKernelWidth [private] |
Limits of Guassian kernel width.
Definition at line 718 of file itkFEMRegistrationFilter.h.
vnl_vector<unsigned int> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Maxiters [private] |
Definition at line 643 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_MaxLevel [private] |
Definition at line 645 of file itkFEMRegistrationFilter.h.
vnl_vector<unsigned int> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_MeshPixelsPerElementAtEachResolution [private] |
Stores the number of pixels per element of the mesh for each resolution of the multi-resolution pyramid
Definition at line 659 of file itkFEMRegistrationFilter.h.
MetricBaseTypePointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Metric [private] |
Definition at line 708 of file itkFEMRegistrationFilter.h.
vnl_vector<unsigned int> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_MetricWidth [private] |
Definition at line 642 of file itkFEMRegistrationFilter.h.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_MinE [private] |
Definition at line 666 of file itkFEMRegistrationFilter.h.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_MinJacobian [private] |
Definition at line 667 of file itkFEMRegistrationFilter.h.
MovingImageType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_MovingImage [private] |
Definition at line 701 of file itkFEMRegistrationFilter.h.
vnl_vector<unsigned int> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_NumberOfIntegrationPoints [private] |
Definition at line 641 of file itkFEMRegistrationFilter.h.
MovingImageType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_OriginalMovingImage [private] |
Definition at line 702 of file itkFEMRegistrationFilter.h.
vnl_vector<Float> itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Rho [private] |
Definition at line 663 of file itkFEMRegistrationFilter.h.
StandardDeviationsType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_StandardDeviations [private] |
Definition at line 720 of file itkFEMRegistrationFilter.h.
Float itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_TimeStep [private] |
Definition at line 661 of file itkFEMRegistrationFilter.h.
FieldType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_TotalField [private] |
Definition at line 688 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_TotalIterations [private] |
Definition at line 644 of file itkFEMRegistrationFilter.h.
bool itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_UseLandmarks [private] |
Definition at line 670 of file itkFEMRegistrationFilter.h.
bool itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_UseMassMatrix [private] |
Definition at line 671 of file itkFEMRegistrationFilter.h.
bool itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_UseNormalizedGradient [private] |
Definition at line 672 of file itkFEMRegistrationFilter.h.
FixedImageType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_WarpedImage [private] |
Definition at line 695 of file itkFEMRegistrationFilter.h.
WarperType::Pointer itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Warper [private] |
Definition at line 692 of file itkFEMRegistrationFilter.h.
unsigned int itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_WhichMetric [private] |
Definition at line 651 of file itkFEMRegistrationFilter.h.
FixedImageType::IndexType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Windex [private] |
Definition at line 698 of file itkFEMRegistrationFilter.h.
FixedImageType::RegionType itk::fem::FEMRegistrationFilter< TMovingImage, TFixedImage, TFemObjectType >::m_Wregion [private] |
Definition at line 697 of file itkFEMRegistrationFilter.h.