go home Home | Main Page | Modules | Namespace List | Class Hierarchy | Alphabetical List | Data Structures | File List | Namespace Members | Data Fields | Globals | Related Pages
Public Types | Public Member Functions | Static Public Member Functions | Protected Member Functions | Private Member Functions | Private Attributes
elastix::AdvancedBSplineTransform< TElastix > Class Template Reference

#include <elxAdvancedBSplineTransform.h>

Detailed Description

template<class TElastix>
class elastix::AdvancedBSplineTransform< TElastix >

A transform based on the itkAdvancedBSplineTransform.

This transform is a B-spline transformation, commonly used for nonrigid registration.

The parameters used in this class are:

Parameters:

Transform: Select this transform as follows:
(Transform "BSplineTransform")

BSplineTransformSplineOrder: choose a B-spline order 1,2, or 3.
example: (BSplineTransformSplineOrder 3)
Default value: 3 (cubic B-splines).

FinalGridSpacingInVoxels: the grid spacing of the B-spline transform for each dimension.
example: (FinalGridSpacingInVoxels 8.0 8.0 8.0)
If only one argument is given, that factor is used for each dimension. The spacing is not in millimeters, but in "voxel size units". The default is 16.0 in every dimension.

FinalGridSpacingInPhysicalUnits: the grid spacing of the B-spline transform for each dimension.
example: (FinalGridSpacingInPhysicalUnits 8.0 8.0 8.0)
If only one argument is given, that factor is used for each dimension. The spacing is specified in millimeters. If not specified, the FinalGridSpacingInVoxels is used, or the FinalGridSpacing, to compute a FinalGridSpacingInPhysicalUnits. If those are not specified, the default value for FinalGridSpacingInVoxels is used to compute a FinalGridSpacingInPhysicalUnits. If an affine transformation is provided as initial transformation, the control grid will be scaled to cover the fixed image domain in the space defined by the initial transformation.

GridSpacingSchedule: the grid spacing downsampling factors for the B-spline transform for each dimension and each resolution.
example: (GridSpacingSchedule 4.0 4.0 2.0 2.0 1.0 1.0)
Which is an example for a 2D image, using 3 resolutions.
For convenience, you may also specify only one value for each resolution:
example: (GridSpacingSchedule 4.0 2.0 1.0 )
which is equivalent to the example above.

PassiveEdgeWidth: the width of a band of control points at the border of the B-spline coefficient image that should remain passive during optimisation.
Can be specified for each resolution.
example: (PassiveEdgeWidth 0 1 2)
The default is zero for all resolutions. A value of 4 will avoid all deformations at the edge of the image. Make sure that 2*PassiveEdgeWidth < ControlPointGridSize in each dimension.

UseCyclicTransform: use the cyclic version of the B-spline transform which ensures that the B-spline polynomials wrap around in the slowest varying dimension. This is useful for dynamic imaging data in which the motion is assumed to be cyclic, for example in ECG-gated or respiratory gated CTA. For more information see the paper: Nonrigid registration of dynamic medical imaging data using nD+t B-splines and a groupwise optimization approach, C.T. Metz, S. Klein, M. Schaap, T. van Walsum and W.J. Niessen, Medical Image Analysis, in press.

The transform parameters necessary for transformix, additionally defined by this class, are:

Transform Parameters:

GridSize: stores the size of the B-spline grid.
example: (GridSize 16 16 16)

GridIndex: stores the index of the B-spline grid.
example: (GridIndex 0 0 0)

GridSpacing: stores the spacing of the B-spline grid.
example: (GridSpacing 16.0 16.0 16.0)

GridOrigin: stores the origin of the B-spline grid.
example: (GridOrigin 0.0 0.0 0.0)

GridDirection: stores the direction cosines of the B-spline grid.
example: (GridDirection 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 0.1)

BSplineTransformSplineOrder: stores the B-spline order 1,2, or 3.
example: (BSplineTransformSplineOrder 3) Default value: 3 (cubic B-splines).

UseCyclicTransform: use the cyclic version of the B-spline transform which ensures that the B-spline polynomials wrap around in the slowest varying dimension. This is useful for dynamic imaging data in which the motion is assumed to be cyclic, for example in ECG-gated or respiratory gated CTA. For more information see the paper: Nonrigid registration of dynamic medical imaging data using nD+t B-splines and a groupwise optimization approach, C.T. Metz, S. Klein, M. Schaap, T. van Walsum and W.J. Niessen, Medical Image Analysis, in press.

Todo:
It is unsure what happens when one of the image dimensions has length 1.

Definition at line 109 of file elxAdvancedBSplineTransform.h.

+ Inheritance diagram for elastix::AdvancedBSplineTransform< TElastix >:

Public Types

typedef BSplineTransformBaseType::Pointer BSplineTransformBasePointer
 
typedef itk::AdvancedBSplineDeformableTransformBase< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro(SpaceDimension) > BSplineTransformBaseType
 
typedef itk::AdvancedBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro(SpaceDimension), 3 > BSplineTransformCubicType
 
typedef itk::AdvancedBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro(SpaceDimension), 1 > BSplineTransformLinearType
 
typedef itk::AdvancedBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro(SpaceDimension), 2 > BSplineTransformQuadraticType
 
typedef Superclass2::CombinationTransformType CombinationTransformType
 
typedef Superclass2::ConfigurationPointer ConfigurationPointer
 
typedef Superclass2::ConfigurationType ConfigurationType
 
typedef itk::SmartPointer< const SelfConstPointer
 
typedef BSplineTransformBaseType::ContinuousIndexType ContinuousIndexType
 
typedef Superclass2::CoordRepType CoordRepType
 
typedef itk::CyclicBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro(SpaceDimension), 3 > CyclicBSplineTransformCubicType
 
typedef itk::CyclicBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro(SpaceDimension), 1 > CyclicBSplineTransformLinearType
 
typedef itk::CyclicBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro(SpaceDimension), 2 > CyclicBSplineTransformQuadraticType
 
typedef itk::CyclicGridScheduleComputer< CoordRepType, SpaceDimension > CyclicGridScheduleComputerType
 
typedef BSplineTransformBaseType::DirectionType DirectionType
 
typedef Superclass2::ElastixPointer ElastixPointer
 
typedef Superclass2::ElastixType ElastixType
 
typedef Superclass2::FixedImageType FixedImageType
 
typedef GridScheduleComputerType::Pointer GridScheduleComputerPointer
 
typedef itk::GridScheduleComputer< CoordRepType, SpaceDimension > GridScheduleComputerType
 
typedef GridScheduleComputerType ::VectorGridSpacingFactorType GridScheduleType
 
typedef GridUpsamplerType::Pointer GridUpsamplerPointer
 
typedef itk::UpsampleBSplineParametersFilter< ParametersType, ImageTypeGridUpsamplerType
 
typedef BSplineTransformBaseType::ImagePointer ImagePointer
 
typedef BSplineTransformBaseType::ImageType ImageType
 
typedef BSplineTransformBaseType::IndexType IndexType
 
typedef Superclass1::InputCovariantVectorType InputCovariantVectorType
 
typedef Superclass1::InputPointType InputPointType
 
typedef Superclass1::InputVectorType InputVectorType
 
typedef Superclass1::InputVnlVectorType InputVnlVectorType
 
typedef Superclass2::ITKBaseType ITKBaseType
 
typedef Superclass1::JacobianType JacobianType
 
typedef Superclass2::MovingImageType MovingImageType
 
typedef Superclass1::NumberOfParametersType NumberOfParametersType
 
typedef BSplineTransformBaseType::OriginType OriginType
 
typedef Superclass1::OutputCovariantVectorType OutputCovariantVectorType
 
typedef Superclass1::OutputPointType OutputPointType
 
typedef Superclass1::OutputVectorType OutputVectorType
 
typedef Superclass1::OutputVnlVectorType OutputVnlVectorType
 
typedef BSplineTransformBaseType::ParameterIndexArrayType ParameterIndexArrayType
 
typedef Superclass2::ParameterMapType ParameterMapType
 
typedef Superclass1::ParametersType ParametersType
 
typedef BSplineTransformBaseType::PixelType PixelType
 
typedef itk::SmartPointer< SelfPointer
 
typedef BSplineTransformBaseType::RegionType RegionType
 
typedef Superclass2::RegistrationPointer RegistrationPointer
 
typedef Superclass2::RegistrationType RegistrationType
 
typedef Superclass1::ScalarType ScalarType
 
typedef AdvancedBSplineTransform Self
 
typedef BSplineTransformBaseType::SizeType SizeType
 
typedef BSplineTransformBaseType::SpacingType SpacingType
 
typedef itk::AdvancedCombinationTransform< typename elx::TransformBase< TElastix >::CoordRepType, elx::TransformBase< TElastix >::FixedImageDimension > Superclass1
 
typedef elx::TransformBase< TElastix > Superclass2
 
- Public Types inherited from itk::AdvancedCombinationTransform< elx::TransformBase< TElastix >::CoordRepType, elx::TransformBase< TElastix >::FixedImageDimension >
typedef SmartPointer< const SelfConstPointer
 
typedef CurrentTransformType::ConstPointer CurrentTransformConstPointer
 
typedef CurrentTransformType::InverseTransformBasePointer CurrentTransformInverseTransformBasePointer
 
typedef CurrentTransformType::InverseTransformBaseType CurrentTransformInverseTransformBaseType
 
typedef CurrentTransformType::Pointer CurrentTransformPointer
 
typedef Superclass CurrentTransformType
 
typedef Superclass::DerivativeType DerivativeType
 
typedef void(Self::* EvaluateJacobianWithImageGradientProductFunctionPointer) (const InputPointType &, const MovingImageGradientType &, DerivativeType &, NonZeroJacobianIndicesType &) const
 
typedef Superclass::FixedParametersType FixedParametersType
 
typedef void(Self::* GetJacobianOfSpatialHessianFunctionPointer) (const InputPointType &, JacobianOfSpatialHessianType &, NonZeroJacobianIndicesType &) const
 
typedef void(Self::* GetJacobianOfSpatialHessianFunctionPointer2) (const InputPointType &, SpatialHessianType &, JacobianOfSpatialHessianType &, NonZeroJacobianIndicesType &) const
 
typedef void(Self::* GetJacobianOfSpatialJacobianFunctionPointer) (const InputPointType &, JacobianOfSpatialJacobianType &, NonZeroJacobianIndicesType &) const
 
typedef void(Self::* GetJacobianOfSpatialJacobianFunctionPointer2) (const InputPointType &, SpatialJacobianType &, JacobianOfSpatialJacobianType &, NonZeroJacobianIndicesType &) const
 
typedef void(Self::* GetSparseJacobianFunctionPointer) (const InputPointType &, JacobianType &, NonZeroJacobianIndicesType &) const
 
typedef void(Self::* GetSpatialHessianFunctionPointer) (const InputPointType &, SpatialHessianType &) const
 
typedef void(Self::* GetSpatialJacobianFunctionPointer) (const InputPointType &, SpatialJacobianType &) const
 
typedef InitialTransformType::ConstPointer InitialTransformConstPointer
 
typedef InitialTransformType::InverseTransformBasePointer InitialTransformInverseTransformBasePointer
 
typedef InitialTransformType::InverseTransformBaseType InitialTransformInverseTransformBaseType
 
typedef InitialTransformType::Pointer InitialTransformPointer
 
typedef Superclass InitialTransformType
 
typedef Superclass::InputCovariantVectorType InputCovariantVectorType
 
typedef Superclass::InputPointType InputPointType
 
typedef Superclass::InputVectorType InputVectorType
 
typedef Superclass::InputVnlVectorType InputVnlVectorType
 
typedef Superclass::InternalMatrixType InternalMatrixType
 
typedef Superclass::InverseTransformBasePointer InverseTransformBasePointer
 
typedef Superclass::InverseTransformBaseType InverseTransformBaseType
 
typedef Superclass::JacobianOfSpatialHessianType JacobianOfSpatialHessianType
 
typedef Superclass::JacobianOfSpatialJacobianType JacobianOfSpatialJacobianType
 
typedef Superclass::JacobianType JacobianType
 
typedef Superclass::MovingImageGradientType MovingImageGradientType
 
typedef Superclass::MovingImageGradientValueType MovingImageGradientValueType
 
typedef Superclass::NonZeroJacobianIndicesType NonZeroJacobianIndicesType
 
typedef Superclass::NumberOfParametersType NumberOfParametersType
 
typedef Superclass::OutputCovariantVectorType OutputCovariantVectorType
 
typedef Superclass::OutputPointType OutputPointType
 
typedef Superclass::OutputVectorType OutputVectorType
 
typedef Superclass::OutputVnlVectorType OutputVnlVectorType
 
typedef Superclass::ParametersType ParametersType
 
typedef Superclass::ParametersValueType ParametersValueType
 
typedef SmartPointer< SelfPointer
 
typedef Superclass::ScalarType ScalarType
 
typedef AdvancedCombinationTransform Self
 
typedef Superclass::SpatialHessianType SpatialHessianType
 
typedef Superclass::SpatialJacobianType SpatialJacobianType
 
typedef AdvancedTransform< elx::TransformBase< TElastix >::CoordRepType, NDimensions, NDimensions > Superclass
 
typedef Superclass::TransformCategoryType TransformCategoryType
 
typedef OutputPointType(Self::* TransformPointFunctionPointer) (const InputPointType &) const
 
typedef Superclass::TransformType TransformType
 
typedef TransformType::ConstPointer TransformTypeConstPointer
 
typedef TransformType::Pointer TransformTypePointer
 
- Public Types inherited from itk::AdvancedTransform< elx::TransformBase< TElastix >::CoordRepType, NDimensions, NDimensions >
typedef SmartPointer< const SelfConstPointer
 
typedef Superclass::DerivativeType DerivativeType
 
typedef Superclass::FixedParametersType FixedParametersType
 
typedef Superclass ::InputCovariantVectorType InputCovariantVectorType
 
typedef Superclass::InputPointType InputPointType
 
typedef Superclass::InputVectorType InputVectorType
 
typedef Superclass::InputVnlVectorType InputVnlVectorType
 
typedef SpatialJacobianType::InternalMatrixType InternalMatrixType
 
typedef Superclass::InverseTransformBasePointer InverseTransformBasePointer
 
typedef Superclass::InverseTransformBaseType InverseTransformBaseType
 
typedef std::vector< SpatialHessianTypeJacobianOfSpatialHessianType
 
typedef std::vector< SpatialJacobianTypeJacobianOfSpatialJacobianType
 
typedef Superclass::JacobianType JacobianType
 
typedef OutputCovariantVectorType MovingImageGradientType
 
typedef MovingImageGradientType::ValueType MovingImageGradientValueType
 
typedef std::vector< unsigned long > NonZeroJacobianIndicesType
 
typedef Superclass::NumberOfParametersType NumberOfParametersType
 
typedef Superclass ::OutputCovariantVectorType OutputCovariantVectorType
 
typedef Superclass::OutputPointType OutputPointType
 
typedef Superclass::OutputVectorType OutputVectorType
 
typedef Superclass::OutputVnlVectorType OutputVnlVectorType
 
typedef Superclass::ParametersType ParametersType
 
typedef Superclass::ParametersValueType ParametersValueType
 
typedef SmartPointer< SelfPointer
 
typedef Superclass::ScalarType ScalarType
 
typedef AdvancedTransform Self
 
typedef FixedArray< Matrix< ScalarType, InputSpaceDimension, InputSpaceDimension >, OutputSpaceDimension > SpatialHessianType
 
typedef Matrix< ScalarType, OutputSpaceDimension, InputSpaceDimension > SpatialJacobianType
 
typedef Transform< elx::TransformBase< TElastix >::CoordRepType, NInputDimensions, NOutputDimensions > Superclass
 
typedef Transform< elx::TransformBase< TElastix >::CoordRepType, NInputDimensions, NOutputDimensions > TransformType
 
typedef TransformType::ConstPointer TransformTypeConstPointer
 
typedef TransformType::Pointer TransformTypePointer
 
- Public Types inherited from elastix::TransformBase< TElastix >
typedef itk::AdvancedCombinationTransform< CoordRepType, itkGetStaticConstMacro(FixedImageDimension) > CombinationTransformType
 
typedef ConfigurationType ::CommandLineArgumentMapType CommandLineArgumentMapType
 
typedef ConfigurationType ::CommandLineEntryType CommandLineEntryType
 
typedef ComponentDatabase ComponentDatabaseType
 
typedef ComponentDatabaseType::ComponentDescriptionType ComponentDescriptionType
 
typedef Superclass::ConfigurationPointer ConfigurationPointer
 
typedef Superclass::ConfigurationType ConfigurationType
 
typedef ElastixType::CoordRepType CoordRepType
 
typedef itk::Image< VectorPixelType, FixedImageDimension > DeformationFieldImageType
 
typedef Superclass::ElastixPointer ElastixPointer
 
typedef Superclass::ElastixType ElastixType
 
typedef ElastixType::FixedImageType FixedImageType
 
typedef CombinationTransformType::InitialTransformType InitialTransformType
 
typedef ITKBaseType::InputPointType InputPointType
 
typedef itk::AdvancedTransform< CoordRepType, itkGetStaticConstMacro(FixedImageDimension), itkGetStaticConstMacro(MovingImageDimension) > ITKBaseType
 
typedef RegistrationType::ITKBaseType ITKRegistrationType
 
typedef ElastixType::MovingImageType MovingImageType
 
typedef itk::Object ObjectType
 
typedef ITKRegistrationType::OptimizerType OptimizerType
 
typedef ITKBaseType::OutputPointType OutputPointType
 
typedef ElastixType::ParameterMapType ParameterMapType
 
typedef ITKBaseType::ParametersType ParametersType
 
typedef elx::ProgressCommand ProgressCommandType
 
typedef ComponentDatabase::PtrToCreator PtrToCreator
 
typedef Superclass::RegistrationPointer RegistrationPointer
 
typedef Superclass::RegistrationType RegistrationType
 
typedef OptimizerType::ScalesType ScalesType
 
typedef TransformBase Self
 
typedef BaseComponentSE< TElastix > Superclass
 
typedef ParametersType::ValueType ValueType
 
typedef itk::Vector< float, FixedImageDimension > VectorPixelType
 
- Public Types inherited from elastix::BaseComponentSE< TElastix >
typedef ElastixType::ConfigurationPointer ConfigurationPointer
 
typedef ElastixType::ConfigurationType ConfigurationType
 
typedef itk::WeakPointer< ElastixTypeElastixPointer
 
typedef TElastix ElastixType
 
typedef RegistrationTypeRegistrationPointer
 
typedef ElastixType::RegistrationBaseType RegistrationType
 
typedef BaseComponentSE Self
 
typedef BaseComponent Superclass
 

Public Member Functions

virtual int BeforeAll (void)
 
virtual void BeforeEachResolution (void)
 
virtual void BeforeRegistration (void)
 
virtual void CreateTransformParametersMap (const ParametersType &param, ParameterMapType *paramsMap) const
 
 elxClassNameMacro ("BSplineTransform")
 
virtual const char * GetClassName () const
 
virtual void IncreaseScale (void)
 
virtual void InitializeTransform (void)
 
 itkStaticConstMacro (SpaceDimension, unsigned int, Superclass2::FixedImageDimension)
 
virtual void ReadFromFile (void)
 
virtual void SetOptimizerScales (const unsigned int edgeWidth)
 
virtual void WriteToFile (const ParametersType &param) const
 
- Public Member Functions inherited from itk::AdvancedCombinationTransform< elx::TransformBase< TElastix >::CoordRepType, elx::TransformBase< TElastix >::FixedImageDimension >
virtual void EvaluateJacobianWithImageGradientProduct (const InputPointType &ipp, const MovingImageGradientType &movingImageGradient, DerivativeType &imageJacobian, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
virtual CurrentTransformTypeGetCurrentTransform ()
 
virtual const CurrentTransformTypeGetCurrentTransform ()
 
virtual const FixedParametersTypeGetFixedParameters (void) const
 
virtual bool GetHasNonZeroSpatialHessian (void) const
 
virtual InitialTransformTypeGetInitialTransform ()
 
virtual const InitialTransformTypeGetInitialTransform ()
 
virtual bool GetInverse (Self *inverse) const
 
virtual void GetJacobian (const InputPointType &ipp, JacobianType &j, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
virtual void GetJacobianOfSpatialHessian (const InputPointType &ipp, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
virtual void GetJacobianOfSpatialHessian (const InputPointType &ipp, SpatialHessianType &sh, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
virtual void GetJacobianOfSpatialJacobian (const InputPointType &ipp, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
virtual void GetJacobianOfSpatialJacobian (const InputPointType &ipp, SpatialJacobianType &sj, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
virtual const TransformTypePointer GetNthTransform (SizeValueType n) const
 
virtual NumberOfParametersType GetNumberOfNonZeroJacobianIndices (void) const
 
virtual NumberOfParametersType GetNumberOfParameters (void) const
 
virtual SizeValueType GetNumberOfTransforms (void) const
 
virtual const ParametersTypeGetParameters (void) const
 
virtual void GetSpatialHessian (const InputPointType &ipp, SpatialHessianType &sh) const
 
virtual void GetSpatialJacobian (const InputPointType &ipp, SpatialJacobianType &sj) const
 
virtual TransformCategoryType GetTransformCategory () const
 
virtual bool GetUseAddition () const
 
virtual bool GetUseComposition () const
 
virtual bool HasNonZeroJacobianOfSpatialHessian (void) const
 
virtual bool IsLinear (void) const
 
 itkStaticConstMacro (SpaceDimension, unsigned int, NDimensions)
 
virtual void SetCurrentTransform (CurrentTransformType *_arg)
 
virtual void SetFixedParameters (const FixedParametersType &fixedParam)
 
virtual void SetInitialTransform (InitialTransformType *_arg)
 
virtual void SetParameters (const ParametersType &param)
 
virtual void SetParametersByValue (const ParametersType &param)
 
virtual void SetUseAddition (bool _arg)
 
virtual void SetUseComposition (bool _arg)
 
virtual OutputCovariantVectorType TransformCovariantVector (const InputCovariantVectorType &) const
 
virtual OutputPointType TransformPoint (const InputPointType &point) const
 
virtual OutputVectorType TransformVector (const InputVectorType &) const
 
virtual OutputVnlVectorType TransformVector (const InputVnlVectorType &) const
 
- Public Member Functions inherited from itk::AdvancedTransform< elx::TransformBase< TElastix >::CoordRepType, NDimensions, NDimensions >
virtual void ComputeJacobianWithRespectToParameters (const InputPointType &, JacobianType &) const
 
virtual void ComputeJacobianWithRespectToPosition (const InputPointType &, JacobianType &) const
 
virtual void EvaluateJacobianWithImageGradientProduct (const InputPointType &ipp, const MovingImageGradientType &movingImageGradient, DerivativeType &imageJacobian, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
virtual bool GetHasNonZeroJacobianOfSpatialHessian () const
 
virtual void GetJacobian (const InputPointType &ipp, JacobianType &j, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const=0
 
virtual void GetJacobianOfSpatialHessian (const InputPointType &ipp, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const=0
 
virtual void GetJacobianOfSpatialHessian (const InputPointType &ipp, SpatialHessianType &sh, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const=0
 
virtual void GetJacobianOfSpatialJacobian (const InputPointType &ipp, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const=0
 
virtual void GetJacobianOfSpatialJacobian (const InputPointType &ipp, SpatialJacobianType &sj, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const=0
 
virtual void GetSpatialHessian (const InputPointType &ipp, SpatialHessianType &sh) const=0
 
virtual void GetSpatialJacobian (const InputPointType &ipp, SpatialJacobianType &sj) const=0
 
 itkStaticConstMacro (InputSpaceDimension, unsigned int, NInputDimensions)
 
 itkStaticConstMacro (OutputSpaceDimension, unsigned int, NOutputDimensions)
 
- Public Member Functions inherited from elastix::TransformBase< TElastix >
virtual void AfterRegistrationBase (void)
 
virtual int BeforeAllBase (void)
 
virtual int BeforeAllTransformix (void)
 
virtual void BeforeRegistrationBase (void)
 
virtual void ComputeDeterminantOfSpatialJacobian (void) const
 
virtual void ComputeSpatialJacobian (void) const
 
DeformationFieldImageType::Pointer GenerateDeformationFieldImage (void) const
 
virtual const CombinationTransformTypeGetAsCombinationTransform (void) const
 
virtual CombinationTransformTypeGetAsCombinationTransform (void)
 
virtual ITKBaseTypeGetAsITKBaseType (void)
 
virtual const ITKBaseTypeGetAsITKBaseType (void) const
 
virtual const InitialTransformTypeGetInitialTransform (void) const
 
virtual const char * GetTransformParametersFileName () const
 
 itkStaticConstMacro (FixedImageDimension, unsigned int, FixedImageType::ImageDimension)
 
 itkStaticConstMacro (MovingImageDimension, unsigned int, MovingImageType::ImageDimension)
 
virtual void ReadInitialTransformFromFile (const char *transformParameterFileName)
 
virtual void ReadInitialTransformFromVector (const vcl_size_t index)
 
virtual void SetFinalParameters (void)
 
virtual void SetInitialTransform (InitialTransformType *_arg)
 
virtual void SetReadWriteTransformParameters (const bool _arg)
 
virtual void SetTransformParametersFileName (const char *filename)
 
virtual void TransformPoints (void) const
 
virtual void TransformPointsAllPoints (void) const
 
virtual void TransformPointsSomePoints (const std::string filename) const
 
virtual void TransformPointsSomePointsVTK (const std::string filename) const
 
void WriteDeformationFieldImage (typename DeformationFieldImageType::Pointer) const
 
virtual void WriteToFile (void) const
 
- Public Member Functions inherited from elastix::BaseComponentSE< TElastix >
virtual ConfigurationTypeGetConfiguration (void) const
 
virtual ElastixTypeGetElastix (void) const
 
virtual RegistrationPointer GetRegistration (void) const
 
virtual void SetConfiguration (ConfigurationType *_arg)
 
virtual void SetElastix (ElastixType *_arg)
 
- Public Member Functions inherited from elastix::BaseComponent
virtual void AfterEachIteration (void)
 
virtual void AfterEachIterationBase (void)
 
virtual void AfterEachResolution (void)
 
virtual void AfterEachResolutionBase (void)
 
virtual void AfterRegistration (void)
 
virtual void BeforeEachResolutionBase (void)
 
std::string ConvertSecondsToDHMS (const double totalSeconds, const unsigned int precision) const
 
virtual const char * elxGetClassName (void) const
 
virtual const char * GetComponentLabel (void) const
 
 itkTypeMacroNoParent (BaseComponent)
 
virtual void SetComponentLabel (const char *label, unsigned int idx)
 

Static Public Member Functions

static Pointer New ()
 
- Static Public Member Functions inherited from itk::AdvancedCombinationTransform< elx::TransformBase< TElastix >::CoordRepType, elx::TransformBase< TElastix >::FixedImageDimension >
static Pointer New ()
 

Protected Member Functions

 AdvancedBSplineTransform ()
 
virtual void PreComputeGridInformation (void)
 
virtual ~AdvancedBSplineTransform ()
 
- Protected Member Functions inherited from itk::AdvancedCombinationTransform< elx::TransformBase< TElastix >::CoordRepType, elx::TransformBase< TElastix >::FixedImageDimension >
 AdvancedCombinationTransform ()
 
void EvaluateJacobianWithImageGradientProductNoCurrentTransform (const InputPointType &, const MovingImageGradientType &, DerivativeType &, NonZeroJacobianIndicesType &) const
 
void EvaluateJacobianWithImageGradientProductNoInitialTransform (const InputPointType &, const MovingImageGradientType &, DerivativeType &, NonZeroJacobianIndicesType &) const
 
void EvaluateJacobianWithImageGradientProductUseAddition (const InputPointType &, const MovingImageGradientType &, DerivativeType &, NonZeroJacobianIndicesType &) const
 
void EvaluateJacobianWithImageGradientProductUseComposition (const InputPointType &, const MovingImageGradientType &, DerivativeType &, NonZeroJacobianIndicesType &) const
 
void GetJacobianNoCurrentTransform (const InputPointType &, JacobianType &, NonZeroJacobianIndicesType &) const
 
void GetJacobianNoInitialTransform (const InputPointType &, JacobianType &, NonZeroJacobianIndicesType &) const
 
void GetJacobianOfSpatialHessianNoCurrentTransform (const InputPointType &ipp, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialHessianNoCurrentTransform (const InputPointType &ipp, SpatialHessianType &sh, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialHessianNoInitialTransform (const InputPointType &ipp, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialHessianNoInitialTransform (const InputPointType &ipp, SpatialHessianType &sh, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialHessianUseAddition (const InputPointType &ipp, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialHessianUseAddition (const InputPointType &ipp, SpatialHessianType &sh, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialHessianUseComposition (const InputPointType &ipp, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
virtual void GetJacobianOfSpatialHessianUseComposition (const InputPointType &ipp, SpatialHessianType &sh, JacobianOfSpatialHessianType &jsh, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialJacobianNoCurrentTransform (const InputPointType &ipp, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialJacobianNoCurrentTransform (const InputPointType &ipp, SpatialJacobianType &sj, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialJacobianNoInitialTransform (const InputPointType &ipp, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialJacobianNoInitialTransform (const InputPointType &ipp, SpatialJacobianType &sj, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialJacobianUseAddition (const InputPointType &ipp, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialJacobianUseAddition (const InputPointType &ipp, SpatialJacobianType &sj, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialJacobianUseComposition (const InputPointType &ipp, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianOfSpatialJacobianUseComposition (const InputPointType &ipp, SpatialJacobianType &sj, JacobianOfSpatialJacobianType &jsj, NonZeroJacobianIndicesType &nonZeroJacobianIndices) const
 
void GetJacobianUseAddition (const InputPointType &, JacobianType &, NonZeroJacobianIndicesType &) const
 
void GetJacobianUseComposition (const InputPointType &, JacobianType &, NonZeroJacobianIndicesType &) const
 
void GetSpatialHessianNoCurrentTransform (const InputPointType &ipp, SpatialHessianType &sh) const
 
void GetSpatialHessianNoInitialTransform (const InputPointType &ipp, SpatialHessianType &sh) const
 
void GetSpatialHessianUseAddition (const InputPointType &ipp, SpatialHessianType &sh) const
 
void GetSpatialHessianUseComposition (const InputPointType &ipp, SpatialHessianType &sh) const
 
void GetSpatialJacobianNoCurrentTransform (const InputPointType &ipp, SpatialJacobianType &sj) const
 
void GetSpatialJacobianNoInitialTransform (const InputPointType &ipp, SpatialJacobianType &sj) const
 
void GetSpatialJacobianUseAddition (const InputPointType &ipp, SpatialJacobianType &sj) const
 
void GetSpatialJacobianUseComposition (const InputPointType &ipp, SpatialJacobianType &sj) const
 
virtual void NoCurrentTransformSet (void) const throw ( ExceptionObject )
 
OutputPointType TransformPointNoCurrentTransform (const InputPointType &point) const
 
OutputPointType TransformPointNoInitialTransform (const InputPointType &point) const
 
OutputPointType TransformPointUseAddition (const InputPointType &point) const
 
OutputPointType TransformPointUseComposition (const InputPointType &point) const
 
virtual void UpdateCombinationMethod (void)
 
virtual ~AdvancedCombinationTransform ()
 
- Protected Member Functions inherited from itk::AdvancedTransform< elx::TransformBase< TElastix >::CoordRepType, NDimensions, NDimensions >
 AdvancedTransform ()
 
 AdvancedTransform (NumberOfParametersType numberOfParameters)
 
virtual ~AdvancedTransform ()
 
- Protected Member Functions inherited from elastix::TransformBase< TElastix >
void AutomaticScalesEstimation (ScalesType &scales) const
 
void AutomaticScalesEstimationStackTransform (const unsigned int &numSubTransforms, ScalesType &scales) const
 
 TransformBase ()
 
virtual ~TransformBase ()
 
- Protected Member Functions inherited from elastix::BaseComponentSE< TElastix >
 BaseComponentSE ()
 
virtual ~BaseComponentSE ()
 
- Protected Member Functions inherited from elastix::BaseComponent
 BaseComponent ()
 
virtual ~BaseComponent ()
 

Private Member Functions

 AdvancedBSplineTransform (const Self &)
 
unsigned int InitializeBSplineTransform ()
 
void operator= (const Self &)
 

Private Attributes

BSplineTransformBasePointer m_BSplineTransform
 
bool m_Cyclic
 
GridScheduleComputerPointer m_GridScheduleComputer
 
GridUpsamplerPointer m_GridUpsampler
 
unsigned int m_SplineOrder
 

Additional Inherited Members

- Protected Attributes inherited from itk::AdvancedCombinationTransform< elx::TransformBase< TElastix >::CoordRepType, elx::TransformBase< TElastix >::FixedImageDimension >
CurrentTransformPointer m_CurrentTransform
 
InitialTransformPointer m_InitialTransform
 
EvaluateJacobianWithImageGradientProductFunctionPointer m_SelectedEvaluateJacobianWithImageGradientProductFunction
 
GetJacobianOfSpatialHessianFunctionPointer m_SelectedGetJacobianOfSpatialHessianFunction
 
GetJacobianOfSpatialHessianFunctionPointer2 m_SelectedGetJacobianOfSpatialHessianFunction2
 
GetJacobianOfSpatialJacobianFunctionPointer m_SelectedGetJacobianOfSpatialJacobianFunction
 
GetJacobianOfSpatialJacobianFunctionPointer2 m_SelectedGetJacobianOfSpatialJacobianFunction2
 
GetSparseJacobianFunctionPointer m_SelectedGetSparseJacobianFunction
 
GetSpatialHessianFunctionPointer m_SelectedGetSpatialHessianFunction
 
GetSpatialJacobianFunctionPointer m_SelectedGetSpatialJacobianFunction
 
TransformPointFunctionPointer m_SelectedTransformPointFunction
 
bool m_UseAddition
 
bool m_UseComposition
 
- Protected Attributes inherited from itk::AdvancedTransform< elx::TransformBase< TElastix >::CoordRepType, NDimensions, NDimensions >
bool m_HasNonZeroJacobianOfSpatialHessian
 
bool m_HasNonZeroSpatialHessian
 
- Protected Attributes inherited from elastix::TransformBase< TElastix >
ParametersType m_FinalParameters
 
std::string m_TransformParametersFileName
 
ParametersTypem_TransformParametersPointer
 
- Protected Attributes inherited from elastix::BaseComponentSE< TElastix >
ConfigurationPointer m_Configuration
 
ElastixPointer m_Elastix
 
RegistrationPointer m_Registration
 

Member Typedef Documentation

◆ BSplineTransformBasePointer

Definition at line 149 of file elxAdvancedBSplineTransform.h.

◆ BSplineTransformBaseType

template<class TElastix >
typedef itk::AdvancedBSplineDeformableTransformBase< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro( SpaceDimension ) > elastix::AdvancedBSplineTransform< TElastix >::BSplineTransformBaseType

The ITK-class that provides most of the functionality, and that is set as the "CurrentTransform" in the CombinationTransform.

Definition at line 148 of file elxAdvancedBSplineTransform.h.

◆ BSplineTransformCubicType

template<class TElastix >
typedef itk::AdvancedBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro( SpaceDimension ), 3 > elastix::AdvancedBSplineTransform< TElastix >::BSplineTransformCubicType

Definition at line 163 of file elxAdvancedBSplineTransform.h.

◆ BSplineTransformLinearType

template<class TElastix >
typedef itk::AdvancedBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro( SpaceDimension ), 1 > elastix::AdvancedBSplineTransform< TElastix >::BSplineTransformLinearType

Typedef for supported BSplineTransform types.

Definition at line 155 of file elxAdvancedBSplineTransform.h.

◆ BSplineTransformQuadraticType

template<class TElastix >
typedef itk::AdvancedBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro( SpaceDimension ), 2 > elastix::AdvancedBSplineTransform< TElastix >::BSplineTransformQuadraticType

Definition at line 159 of file elxAdvancedBSplineTransform.h.

◆ CombinationTransformType

Definition at line 217 of file elxAdvancedBSplineTransform.h.

◆ ConfigurationPointer

Definition at line 210 of file elxAdvancedBSplineTransform.h.

◆ ConfigurationType

Definition at line 209 of file elxAdvancedBSplineTransform.h.

◆ ConstPointer

template<class TElastix >
typedef itk::SmartPointer< const Self > elastix::AdvancedBSplineTransform< TElastix >::ConstPointer

Definition at line 126 of file elxAdvancedBSplineTransform.h.

◆ ContinuousIndexType

Definition at line 202 of file elxAdvancedBSplineTransform.h.

◆ CoordRepType

template<class TElastix >
typedef Superclass2::CoordRepType elastix::AdvancedBSplineTransform< TElastix >::CoordRepType

Definition at line 213 of file elxAdvancedBSplineTransform.h.

◆ CyclicBSplineTransformCubicType

template<class TElastix >
typedef itk::CyclicBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro( SpaceDimension ), 3 > elastix::AdvancedBSplineTransform< TElastix >::CyclicBSplineTransformCubicType

Definition at line 175 of file elxAdvancedBSplineTransform.h.

◆ CyclicBSplineTransformLinearType

template<class TElastix >
typedef itk::CyclicBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro( SpaceDimension ), 1 > elastix::AdvancedBSplineTransform< TElastix >::CyclicBSplineTransformLinearType

Definition at line 167 of file elxAdvancedBSplineTransform.h.

◆ CyclicBSplineTransformQuadraticType

template<class TElastix >
typedef itk::CyclicBSplineDeformableTransform< typename elx::TransformBase< TElastix >::CoordRepType, itkGetStaticConstMacro( SpaceDimension ), 2 > elastix::AdvancedBSplineTransform< TElastix >::CyclicBSplineTransformQuadraticType

Definition at line 171 of file elxAdvancedBSplineTransform.h.

◆ CyclicGridScheduleComputerType

template<class TElastix >
typedef itk::CyclicGridScheduleComputer< CoordRepType, SpaceDimension > elastix::AdvancedBSplineTransform< TElastix >::CyclicGridScheduleComputerType

Definition at line 223 of file elxAdvancedBSplineTransform.h.

◆ DirectionType

Definition at line 200 of file elxAdvancedBSplineTransform.h.

◆ ElastixPointer

template<class TElastix >
typedef Superclass2::ElastixPointer elastix::AdvancedBSplineTransform< TElastix >::ElastixPointer

Definition at line 208 of file elxAdvancedBSplineTransform.h.

◆ ElastixType

template<class TElastix >
typedef Superclass2::ElastixType elastix::AdvancedBSplineTransform< TElastix >::ElastixType

Typedef's from TransformBase.

Definition at line 207 of file elxAdvancedBSplineTransform.h.

◆ FixedImageType

template<class TElastix >
typedef Superclass2::FixedImageType elastix::AdvancedBSplineTransform< TElastix >::FixedImageType

Definition at line 214 of file elxAdvancedBSplineTransform.h.

◆ GridScheduleComputerPointer

Definition at line 224 of file elxAdvancedBSplineTransform.h.

◆ GridScheduleComputerType

template<class TElastix >
typedef itk::GridScheduleComputer< CoordRepType, SpaceDimension > elastix::AdvancedBSplineTransform< TElastix >::GridScheduleComputerType

Typedef's for the GridScheduleComputer and the UpsampleBSplineParametersFilter.

Definition at line 221 of file elxAdvancedBSplineTransform.h.

◆ GridScheduleType

template<class TElastix >
typedef GridScheduleComputerType ::VectorGridSpacingFactorType elastix::AdvancedBSplineTransform< TElastix >::GridScheduleType

Definition at line 226 of file elxAdvancedBSplineTransform.h.

◆ GridUpsamplerPointer

Definition at line 229 of file elxAdvancedBSplineTransform.h.

◆ GridUpsamplerType

Definition at line 228 of file elxAdvancedBSplineTransform.h.

◆ ImagePointer

Definition at line 194 of file elxAdvancedBSplineTransform.h.

◆ ImageType

Definition at line 193 of file elxAdvancedBSplineTransform.h.

◆ IndexType

Definition at line 196 of file elxAdvancedBSplineTransform.h.

◆ InputCovariantVectorType

Definition at line 184 of file elxAdvancedBSplineTransform.h.

◆ InputPointType

template<class TElastix >
typedef Superclass1::InputPointType elastix::AdvancedBSplineTransform< TElastix >::InputPointType

Definition at line 188 of file elxAdvancedBSplineTransform.h.

◆ InputVectorType

template<class TElastix >
typedef Superclass1::InputVectorType elastix::AdvancedBSplineTransform< TElastix >::InputVectorType

Definition at line 182 of file elxAdvancedBSplineTransform.h.

◆ InputVnlVectorType

Definition at line 186 of file elxAdvancedBSplineTransform.h.

◆ ITKBaseType

template<class TElastix >
typedef Superclass2::ITKBaseType elastix::AdvancedBSplineTransform< TElastix >::ITKBaseType

Definition at line 216 of file elxAdvancedBSplineTransform.h.

◆ JacobianType

template<class TElastix >
typedef Superclass1::JacobianType elastix::AdvancedBSplineTransform< TElastix >::JacobianType

Definition at line 181 of file elxAdvancedBSplineTransform.h.

◆ MovingImageType

template<class TElastix >
typedef Superclass2::MovingImageType elastix::AdvancedBSplineTransform< TElastix >::MovingImageType

Definition at line 215 of file elxAdvancedBSplineTransform.h.

◆ NumberOfParametersType

Definition at line 180 of file elxAdvancedBSplineTransform.h.

◆ OriginType

Definition at line 199 of file elxAdvancedBSplineTransform.h.

◆ OutputCovariantVectorType

Definition at line 185 of file elxAdvancedBSplineTransform.h.

◆ OutputPointType

template<class TElastix >
typedef Superclass1::OutputPointType elastix::AdvancedBSplineTransform< TElastix >::OutputPointType

Definition at line 189 of file elxAdvancedBSplineTransform.h.

◆ OutputVectorType

Definition at line 183 of file elxAdvancedBSplineTransform.h.

◆ OutputVnlVectorType

Definition at line 187 of file elxAdvancedBSplineTransform.h.

◆ ParameterIndexArrayType

Definition at line 204 of file elxAdvancedBSplineTransform.h.

◆ ParameterMapType

Typedef that is used in the elastix dll version.

Definition at line 232 of file elxAdvancedBSplineTransform.h.

◆ ParametersType

template<class TElastix >
typedef Superclass1::ParametersType elastix::AdvancedBSplineTransform< TElastix >::ParametersType

Definition at line 179 of file elxAdvancedBSplineTransform.h.

◆ PixelType

Typedef's specific for the BSplineTransform.

Definition at line 192 of file elxAdvancedBSplineTransform.h.

◆ Pointer

template<class TElastix >
typedef itk::SmartPointer< Self > elastix::AdvancedBSplineTransform< TElastix >::Pointer

Definition at line 125 of file elxAdvancedBSplineTransform.h.

◆ RegionType

Definition at line 195 of file elxAdvancedBSplineTransform.h.

◆ RegistrationPointer

Definition at line 212 of file elxAdvancedBSplineTransform.h.

◆ RegistrationType

Definition at line 211 of file elxAdvancedBSplineTransform.h.

◆ ScalarType

template<class TElastix >
typedef Superclass1::ScalarType elastix::AdvancedBSplineTransform< TElastix >::ScalarType

Typedefs inherited from the superclass.

Definition at line 178 of file elxAdvancedBSplineTransform.h.

◆ Self

template<class TElastix >
typedef AdvancedBSplineTransform elastix::AdvancedBSplineTransform< TElastix >::Self

Standard ITK-stuff.

Definition at line 120 of file elxAdvancedBSplineTransform.h.

◆ SizeType

template<class TElastix >
typedef BSplineTransformBaseType::SizeType elastix::AdvancedBSplineTransform< TElastix >::SizeType

Definition at line 197 of file elxAdvancedBSplineTransform.h.

◆ SpacingType

Definition at line 198 of file elxAdvancedBSplineTransform.h.

◆ Superclass1

template<class TElastix >
typedef itk::AdvancedCombinationTransform< typename elx::TransformBase< TElastix >::CoordRepType, elx::TransformBase< TElastix >::FixedImageDimension > elastix::AdvancedBSplineTransform< TElastix >::Superclass1

Definition at line 123 of file elxAdvancedBSplineTransform.h.

◆ Superclass2

template<class TElastix >
typedef elx::TransformBase< TElastix > elastix::AdvancedBSplineTransform< TElastix >::Superclass2

Definition at line 124 of file elxAdvancedBSplineTransform.h.

Constructor & Destructor Documentation

◆ AdvancedBSplineTransform() [1/2]

template<class TElastix >
elastix::AdvancedBSplineTransform< TElastix >::AdvancedBSplineTransform ( )
protected

The constructor.

◆ ~AdvancedBSplineTransform()

template<class TElastix >
virtual elastix::AdvancedBSplineTransform< TElastix >::~AdvancedBSplineTransform ( )
inlineprotectedvirtual

The destructor.

Definition at line 295 of file elxAdvancedBSplineTransform.h.

◆ AdvancedBSplineTransform() [2/2]

template<class TElastix >
elastix::AdvancedBSplineTransform< TElastix >::AdvancedBSplineTransform ( const Self )
private

The private constructor.

Member Function Documentation

◆ BeforeAll()

template<class TElastix >
virtual int elastix::AdvancedBSplineTransform< TElastix >::BeforeAll ( void  )
virtual

Execute stuff before anything else is done:

  • Initialize the right BSplineTransform.
  • Initialize the right grid schedule computer.

Reimplemented from elastix::BaseComponent.

◆ BeforeEachResolution()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::BeforeEachResolution ( void  )
virtual

Execute stuff before each new pyramid resolution:

Reimplemented from elastix::BaseComponent.

◆ BeforeRegistration()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::BeforeRegistration ( void  )
virtual

Execute stuff before the actual registration:

  • Create an initial B-spline grid.
  • Create initial registration parameters.
  • PrecomputeGridInformation Initially, the transform is set to use a 1x1x1 grid, with deformation (0,0,0). In the method BeforeEachResolution() this will be replaced by the right grid size. This seems not logical, but it is required, since the registration class checks if the number of parameters in the transform is equal to the number of parameters in the registration class. This check is done before calling the BeforeEachResolution() methods.

Reimplemented from elastix::BaseComponent.

◆ CreateTransformParametersMap()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::CreateTransformParametersMap ( const ParametersType param,
ParameterMapType paramsMap 
) const
virtual

Function to create transform-parameters map. Creates the TransformParametersmap as a vector and if wanted also as a deformation field.

Reimplemented from elastix::TransformBase< TElastix >.

◆ elxClassNameMacro()

template<class TElastix >
elastix::AdvancedBSplineTransform< TElastix >::elxClassNameMacro ( "BSplineTransform"  )

Name of this class. Use this name in the parameter file to select this specific transform.
example: (Transform "BSplineTransform")

◆ GetClassName()

template<class TElastix >
virtual const char* elastix::AdvancedBSplineTransform< TElastix >::GetClassName ( ) const
virtual

Run-time type information (and related methods).

Reimplemented from elastix::TransformBase< TElastix >.

◆ IncreaseScale()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::IncreaseScale ( void  )
virtual

Method to increase the density of the B-spline grid.

  • Determine the new B-spline coefficients that describe the current deformation field.
  • Set these coefficients as InitialParametersOfNextLevel in the registration object. Called by BeforeEachResolution().

◆ InitializeBSplineTransform()

template<class TElastix >
unsigned int elastix::AdvancedBSplineTransform< TElastix >::InitializeBSplineTransform ( )
private

Initialize the right B-spline transform based on the spline order and periodicity.

◆ InitializeTransform()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::InitializeTransform ( void  )
virtual

Method to set the initial B-spline grid and initialize the parameters (to 0).

  • Define the initial grid region, origin and spacing, using the precomputed grid information.
  • Set the initial parameters to zero and set then as InitialParametersOfNextLevel in the registration object. Called by BeforeEachResolution().

◆ itkStaticConstMacro()

template<class TElastix >
elastix::AdvancedBSplineTransform< TElastix >::itkStaticConstMacro ( SpaceDimension  ,
unsigned  int,
Superclass2::FixedImageDimension   
)

Dimension of the fixed image.

◆ New()

template<class TElastix >
static Pointer elastix::AdvancedBSplineTransform< TElastix >::New ( )
static

Method for creation through the object factory.

◆ operator=()

template<class TElastix >
void elastix::AdvancedBSplineTransform< TElastix >::operator= ( const Self )
private

The private copy constructor.

◆ PreComputeGridInformation()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::PreComputeGridInformation ( void  )
protectedvirtual

Read user-specified grid spacing and call the itkGridScheduleComputer.

◆ ReadFromFile()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::ReadFromFile ( void  )
virtual

Function to read transform-parameters from a file.

Reimplemented from elastix::TransformBase< TElastix >.

◆ SetOptimizerScales()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::SetOptimizerScales ( const unsigned int  edgeWidth)
virtual

Set the scales of the edge B-spline coefficients to zero.

◆ WriteToFile()

template<class TElastix >
virtual void elastix::AdvancedBSplineTransform< TElastix >::WriteToFile ( const ParametersType param) const
virtual

Function to write transform-parameters to a file.

Reimplemented from elastix::TransformBase< TElastix >.

Field Documentation

◆ m_BSplineTransform

template<class TElastix >
BSplineTransformBasePointer elastix::AdvancedBSplineTransform< TElastix >::m_BSplineTransform
private

Private variables.

Definition at line 308 of file elxAdvancedBSplineTransform.h.

◆ m_Cyclic

template<class TElastix >
bool elastix::AdvancedBSplineTransform< TElastix >::m_Cyclic
private

Definition at line 314 of file elxAdvancedBSplineTransform.h.

◆ m_GridScheduleComputer

template<class TElastix >
GridScheduleComputerPointer elastix::AdvancedBSplineTransform< TElastix >::m_GridScheduleComputer
private

Definition at line 309 of file elxAdvancedBSplineTransform.h.

◆ m_GridUpsampler

template<class TElastix >
GridUpsamplerPointer elastix::AdvancedBSplineTransform< TElastix >::m_GridUpsampler
private

Definition at line 310 of file elxAdvancedBSplineTransform.h.

◆ m_SplineOrder

template<class TElastix >
unsigned int elastix::AdvancedBSplineTransform< TElastix >::m_SplineOrder
private

Variables to remember order and periodicity of B-spline transform.

Definition at line 313 of file elxAdvancedBSplineTransform.h.



Generated on OURCE_DATE_EPOCH for elastix by doxygen 1.8.13 elastix logo