ITK  5.2.0
Insight Toolkit
Public Types | List of all members
itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder > Class Template Reference

#include <itkBSplineDeformableTransform.h>

+ Inheritance diagram for itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >:
+ Collaboration diagram for itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >:

Public Types

using ConstPointer = SmartPointer< const Self >
 
using Pointer = SmartPointer< Self >
 
using Self = BSplineDeformableTransform
 
using Superclass = BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >
 
- Public Types inherited from itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >
using ConstPointer = SmartPointer< const Self >
 
using FixedParametersType = typename Superclass::FixedParametersType
 
using InputCovariantVectorType = CovariantVector< TParametersValueType, Self::SpaceDimension >
 
using InputPointType = Point< TParametersValueType, Self::SpaceDimension >
 
using InputVectorType = Vector< TParametersValueType, Self::SpaceDimension >
 
using InputVnlVectorType = vnl_vector_fixed< TParametersValueType, SpaceDimension >
 
using InverseJacobianPositionType = typename Superclass::InverseJacobianPositionType
 
using JacobianPositionType = typename Superclass::JacobianPositionType
 
using JacobianType = typename Superclass::JacobianType
 
using NumberOfParametersType = typename Superclass::NumberOfParametersType
 
using OutputCovariantVectorType = CovariantVector< TParametersValueType, Self::SpaceDimension >
 
using OutputPointType = Point< TParametersValueType, Self::SpaceDimension >
 
using OutputVectorType = Vector< TParametersValueType, Self::SpaceDimension >
 
using OutputVnlVectorType = vnl_vector_fixed< TParametersValueType, SpaceDimension >
 
using ParametersType = typename Superclass::ParametersType
 
using Pointer = SmartPointer< Self >
 
using ScalarType = typename Superclass::ScalarType
 
using Self = BSplineBaseTransform
 
using Superclass = Transform< TParametersValueType, NDimensions, NDimensions >
 
using TransformCategoryEnum = typename Superclass::TransformCategoryEnum
 
using ParametersValueType = typename ParametersType::ValueType
 
using ImageType = Image< ParametersValueType, Self::SpaceDimension >
 
using ImagePointer = typename ImageType::Pointer
 
using CoefficientImageArray = FixedArray< ImagePointer, NDimensions >
 
using DerivativeType = typename Superclass::DerivativeType
 
using RegionType = ImageRegion< Self::SpaceDimension >
 
using IndexType = typename RegionType::IndexType
 
using SizeType = typename RegionType::SizeType
 
using SpacingType = typename ImageType::SpacingType
 
using DirectionType = typename ImageType::DirectionType
 
using OriginType = typename ImageType::PointType
 
using WeightsFunctionType = BSplineInterpolationWeightFunction< ScalarType, Self::SpaceDimension, Self::SplineOrder >
 
using WeightsType = typename WeightsFunctionType::WeightsType
 
using ContinuousIndexType = typename WeightsFunctionType::ContinuousIndexType
 
using ParameterIndexArrayType = Array< unsigned long >
 
using PhysicalDimensionsType = typename ImageType::SpacingType
 
using PixelType = typename ImageType::PixelType
 
using MeshSizeType = SizeType
 
- Public Types inherited from itk::Transform< TParametersValueType, NDimensions, NDimensions >
using ConstPointer = SmartPointer< const Self >
 
using DerivativeType = Array< ParametersValueType >
 
using DirectionChangeMatrix = Matrix< double, Self::OutputSpaceDimension, Self::InputSpaceDimension >
 
using FixedParametersType = typename Superclass::FixedParametersType
 
using FixedParametersValueType = typename Superclass::FixedParametersValueType
 
using InputCovariantVectorType = CovariantVector< TParametersValueType, NInputDimensions >
 
using InputDiffusionTensor3DType = DiffusionTensor3D< TParametersValueType >
 
using InputDirectionMatrix = Matrix< double, Self::InputSpaceDimension, Self::InputSpaceDimension >
 
using InputPointType = Point< TParametersValueType, NInputDimensions >
 
using InputSymmetricSecondRankTensorType = SymmetricSecondRankTensor< TParametersValueType, NInputDimensions >
 
using InputVectorPixelType = VariableLengthVector< TParametersValueType >
 
using InputVectorType = Vector< TParametersValueType, NInputDimensions >
 
using InputVnlVectorType = vnl_vector_fixed< TParametersValueType, NInputDimensions >
 
using InverseJacobianPositionType = vnl_matrix_fixed< ParametersValueType, NInputDimensions, NOutputDimensions >
 
using InverseTransformBasePointer = typename InverseTransformBaseType::Pointer
 
using InverseTransformBaseType = Transform< TParametersValueType, NOutputDimensions, NInputDimensions >
 
using JacobianPositionType = vnl_matrix_fixed< ParametersValueType, NOutputDimensions, NInputDimensions >
 
using JacobianType = Array2D< ParametersValueType >
 
using MatrixType = Matrix< TParametersValueType, Self::OutputSpaceDimension, Self::InputSpaceDimension >
 
using NumberOfParametersType = typename Superclass::NumberOfParametersType
 
using OutputCovariantVectorType = CovariantVector< TParametersValueType, NOutputDimensions >
 
using OutputDiffusionTensor3DType = DiffusionTensor3D< TParametersValueType >
 
using OutputDirectionMatrix = Matrix< double, Self::OutputSpaceDimension, Self::OutputSpaceDimension >
 
using OutputPointType = Point< TParametersValueType, NOutputDimensions >
 
using OutputSymmetricSecondRankTensorType = SymmetricSecondRankTensor< TParametersValueType, NOutputDimensions >
 
using OutputVectorPixelType = VariableLengthVector< TParametersValueType >
 
using OutputVectorType = Vector< TParametersValueType, NOutputDimensions >
 
using OutputVnlVectorType = vnl_vector_fixed< TParametersValueType, NOutputDimensions >
 
using ParametersType = typename Superclass::ParametersType
 
using ParametersValueType = typename Superclass::ParametersValueType
 
using Pointer = SmartPointer< Self >
 
using ScalarType = ParametersValueType
 
using Self = Transform
 
using Superclass = TransformBaseTemplate< TParametersValueType >
 
using TransformCategoryEnum = typename Superclass::TransformCategoryEnum
 
- Public Types inherited from itk::TransformBaseTemplate< TParametersValueType >
using ConstPointer = SmartPointer< const Self >
 
using FixedParametersType = OptimizerParameters< FixedParametersValueType >
 
using FixedParametersValueType = double
 
using NumberOfParametersType = IdentifierType
 
using ParametersType = OptimizerParameters< ParametersValueType >
 
using ParametersValueType = TParametersValueType
 
using Pointer = SmartPointer< Self >
 
using Self = TransformBaseTemplate
 
using Superclass = Object
 
using TransformCategoryEnum = TransformBaseTemplateEnums::TransformCategory
 
- Public Types inherited from itk::Object
using ConstPointer = SmartPointer< const Self >
 
using Pointer = SmartPointer< Self >
 
using Self = Object
 
using Superclass = LightObject
 
- Public Types inherited from itk::LightObject
using ConstPointer = SmartPointer< const Self >
 
using Pointer = SmartPointer< Self >
 
using Self = LightObject
 
using ScalarType = TParametersValueType
 
using ParametersType = typename Superclass::ParametersType
 
using ParametersValueType = typename Superclass::ParametersValueType
 
using FixedParametersType = typename Superclass::FixedParametersType
 
using FixedParametersValueType = typename Superclass::FixedParametersValueType
 
using JacobianType = typename Superclass::JacobianType
 
using JacobianPositionType = typename Superclass::JacobianPositionType
 
using InverseJacobianPositionType = typename Superclass::InverseJacobianPositionType
 
using NumberOfParametersType = typename Superclass::NumberOfParametersType
 
using InputVectorType = typename Superclass::InputVectorType
 
using OutputVectorType = typename Superclass::OutputVectorType
 
using InputCovariantVectorType = typename Superclass::InputCovariantVectorType
 
using OutputCovariantVectorType = typename Superclass::OutputCovariantVectorType
 
using InputVnlVectorType = typename Superclass::InputVnlVectorType
 
using OutputVnlVectorType = typename Superclass::OutputVnlVectorType
 
using InputPointType = Point< TParametersValueType, Self::SpaceDimension >
 
using OutputPointType = Point< TParametersValueType, Self::SpaceDimension >
 
using ImageType = typename Superclass::ImageType
 
using ImagePointer = typename Superclass::ImagePointer
 
using CoefficientImageArray = typename Superclass::CoefficientImageArray
 
using RegionType = typename Superclass::RegionType
 
using IndexType = typename Superclass::IndexType
 
using SizeType = typename Superclass::SizeType
 
using SpacingType = typename Superclass::SpacingType
 
using DirectionType = typename Superclass::DirectionType
 
using OriginType = typename Superclass::OriginType
 
using WeightsFunctionType = typename Superclass::WeightsFunctionType
 
using WeightsType = typename Superclass::WeightsType
 
using ContinuousIndexType = typename Superclass::ContinuousIndexType
 
using ParameterIndexArrayType = typename Superclass::ParameterIndexArrayType
 
using PhysicalDimensionsType = typename Superclass::SpacingType
 
using PixelType = typename Superclass::PixelType
 
using MeshSizeType = typename Superclass::MeshSizeType
 
using BulkTransformType = Transform< TParametersValueType, Self::SpaceDimension, Self::SpaceDimension >
 
using BulkTransformPointer = typename BulkTransformType::ConstPointer
 
static constexpr unsigned int SpaceDimension = NDimensions
 
static constexpr unsigned int SplineOrder = VSplineOrder
 
const RegionTypem_GridRegion
 
const OriginTypem_GridOrigin
 
const SpacingTypem_GridSpacing
 
const DirectionTypem_GridDirection
 
BulkTransformPointer m_BulkTransform
 
RegionType m_ValidRegion
 
unsigned long m_Offset
 
bool m_SplineOrderOdd
 
IndexType m_ValidRegionLast
 
IndexType m_ValidRegionFirst
 
static Pointer New ()
 
::itk::LightObject::Pointer CreateAnother () const override
 
 itkCloneMacro (Self)
 
virtual const char * GetNameOfClass () const
 
void SetFixedParameters (const FixedParametersType &passedParameters) override
 
void SetCoefficientImages (const CoefficientImageArray &images) override
 
void TransformPoint (const InputPointType &inputPoint, OutputPointType &outputPoint, WeightsType &weights, ParameterIndexArrayType &indices, bool &inside) const override
 
void ComputeJacobianWithRespectToParameters (const InputPointType &, JacobianType &) const override
 
NumberOfParametersType GetNumberOfParameters () const override
 
NumberOfParametersType GetNumberOfParametersPerDimension () const override
 
virtual void SetGridOrigin (const OriginType &)
 
virtual OriginType GetGridOrigin () const
 
virtual void SetGridSpacing (const SpacingType &)
 
virtual SpacingType GetGridSpacing () const
 
virtual void SetGridDirection (const DirectionType &)
 
virtual DirectionType GetGridDirection () const
 
virtual void SetGridRegion (const RegionType &)
 
virtual RegionType GetGridRegion () const
 
virtual void SetBulkTransform (const BulkTransformType *_arg)
 
virtual const BulkTransformTypeGetBulkTransform () const
 
virtual const RegionTypeGetValidRegion () const
 
void PrintSelf (std::ostream &os, Indent indent) const override
 
 BSplineDeformableTransform ()
 
 ~BSplineDeformableTransform () override=default
 
void SetFixedParametersGridSizeFromTransformDomainInformation () const override
 
void SetFixedParametersGridOriginFromTransformDomainInformation () const override
 
void SetFixedParametersGridSpacingFromTransformDomainInformation () const override
 
void SetFixedParametersGridDirectionFromTransformDomainInformation () const override
 
void SetCoefficientImageInformationFromFixedParameters () override
 
bool InsideValidRegion (ContinuousIndexType &) const override
 
void UpdateValidGridRegion ()
 

Additional Inherited Members

- Public Member Functions inherited from itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >
 itkCloneMacro (Self)
 
void SetParameters (const ParametersType &parameters) override
 
void SetParametersByValue (const ParametersType &parameters) override
 
void SetIdentity ()
 
const ParametersTypeGetParameters () const override
 
const FixedParametersTypeGetFixedParameters () const override
 
const CoefficientImageArray GetCoefficientImages () const
 
void UpdateTransformParameters (const DerivativeType &update, TParametersValueType factor=1.0) override
 
OutputPointType TransformPoint (const InputPointType &point) const override
 
unsigned long GetNumberOfWeights () const
 
OutputVectorType TransformVector (const InputVectorType &) const override
 
OutputVnlVectorType TransformVector (const InputVnlVectorType &) const override
 
OutputCovariantVectorType TransformCovariantVector (const InputCovariantVectorType &) const override
 
void ComputeJacobianFromBSplineWeightsWithRespectToPosition (const InputPointType &, WeightsType &, ParameterIndexArrayType &) const
 
void ComputeJacobianWithRespectToPosition (const InputPointType &, JacobianPositionType &) const override
 
TransformCategoryEnum GetTransformCategory () const override
 
unsigned int GetNumberOfAffectedWeights () const
 
NumberOfParametersType GetNumberOfLocalParameters () const override
 
- Public Member Functions inherited from itk::Transform< TParametersValueType, NDimensions, NDimensions >
void CopyInFixedParameters (const FixedParametersValueType *const begin, const FixedParametersValueType *const end) override
 
void CopyInParameters (const ParametersValueType *const begin, const ParametersValueType *const end) override
 
const FixedParametersTypeGetFixedParameters () const override
 
unsigned int GetInputSpaceDimension () const override
 
bool GetInverse (Self *) const
 
virtual InverseTransformBasePointer GetInverseTransform () const
 
virtual NumberOfParametersType GetNumberOfFixedParameters () const
 
NumberOfParametersType GetNumberOfParameters () const override
 
unsigned int GetOutputSpaceDimension () const override
 
const ParametersTypeGetParameters () const override
 
TransformCategoryEnum GetTransformCategory () const override
 
std::string GetTransformTypeAsString () const override
 
virtual bool IsLinear () const
 
 itkCloneMacro (Self)
 
void SetFixedParameters (const FixedParametersType &) override=0
 
void SetParameters (const ParametersType &) override=0
 
void SetParametersByValue (const ParametersType &p) override
 
virtual OutputCovariantVectorType TransformCovariantVector (const InputCovariantVectorType &) const
 
virtual OutputCovariantVectorType TransformCovariantVector (const InputCovariantVectorType &vector, const InputPointType &point) const
 
virtual OutputVectorPixelType TransformCovariantVector (const InputVectorPixelType &) const
 
virtual OutputVectorPixelType TransformCovariantVector (const InputVectorPixelType &vector, const InputPointType &point) const
 
virtual OutputDiffusionTensor3DType TransformDiffusionTensor3D (const InputDiffusionTensor3DType &) const
 
virtual OutputDiffusionTensor3DType TransformDiffusionTensor3D (const InputDiffusionTensor3DType &inputTensor, const InputPointType &point) const
 
virtual OutputVectorPixelType TransformDiffusionTensor3D (const InputVectorPixelType &) const
 
virtual OutputVectorPixelType TransformDiffusionTensor3D (const InputVectorPixelType &inputTensor, const InputPointType &point) const
 
virtual OutputPointType TransformPoint (const InputPointType &) const=0
 
virtual OutputSymmetricSecondRankTensorType TransformSymmetricSecondRankTensor (const InputSymmetricSecondRankTensorType &) const
 
virtual OutputSymmetricSecondRankTensorType TransformSymmetricSecondRankTensor (const InputSymmetricSecondRankTensorType &inputTensor, const InputPointType &point) const
 
virtual OutputVectorPixelType TransformSymmetricSecondRankTensor (const InputVectorPixelType &) const
 
virtual OutputVectorPixelType TransformSymmetricSecondRankTensor (const InputVectorPixelType &inputTensor, const InputPointType &point) const
 
virtual OutputVectorPixelType TransformVector (const InputVectorPixelType &) const
 
virtual OutputVectorPixelType TransformVector (const InputVectorPixelType &vector, const InputPointType &point) const
 
virtual OutputVectorType TransformVector (const InputVectorType &) const
 
virtual OutputVectorType TransformVector (const InputVectorType &vector, const InputPointType &point) const
 
virtual OutputVnlVectorType TransformVector (const InputVnlVectorType &) const
 
virtual OutputVnlVectorType TransformVector (const InputVnlVectorType &vector, const InputPointType &point) const
 
virtual void UpdateTransformParameters (const DerivativeType &update, ParametersValueType factor=1.0)
 
virtual void ComputeJacobianWithRespectToParameters (const InputPointType &, JacobianType &) const=0
 
virtual void ComputeJacobianWithRespectToParametersCachedTemporaries (const InputPointType &p, JacobianType &jacobian, JacobianType &) const
 
virtual void ComputeJacobianWithRespectToPosition (const InputPointType &, JacobianPositionType &) const
 
 itkLegacyMacro (virtual void ComputeJacobianWithRespectToPosition(const InputPointType &x, JacobianType &jacobian) const)
 
 itkLegacyMacro (virtual void ComputeInverseJacobianWithRespectToPosition(const InputPointType &x, JacobianType &jacobian) const)
 
virtual void ComputeInverseJacobianWithRespectToPosition (const InputPointType &pnt, InverseJacobianPositionType &jacobian) const
 
- Public Member Functions inherited from itk::Object
unsigned long AddObserver (const EventObject &event, Command *)
 
unsigned long AddObserver (const EventObject &event, Command *) const
 
unsigned long AddObserver (const EventObject &event, std::function< void(const EventObject &)> function) const
 
virtual void DebugOff () const
 
virtual void DebugOn () const
 
CommandGetCommand (unsigned long tag)
 
bool GetDebug () const
 
MetaDataDictionaryGetMetaDataDictionary ()
 
const MetaDataDictionaryGetMetaDataDictionary () const
 
virtual ModifiedTimeType GetMTime () const
 
virtual const TimeStampGetTimeStamp () const
 
bool HasObserver (const EventObject &event) const
 
void InvokeEvent (const EventObject &)
 
void InvokeEvent (const EventObject &) const
 
virtual void Modified () const
 
void Register () const override
 
void RemoveAllObservers ()
 
void RemoveObserver (unsigned long tag)
 
void SetDebug (bool debugFlag) const
 
void SetReferenceCount (int) override
 
void UnRegister () const noexcept override
 
void SetMetaDataDictionary (const MetaDataDictionary &rhs)
 
void SetMetaDataDictionary (MetaDataDictionary &&rrhs)
 
virtual void SetObjectName (std::string _arg)
 
virtual const std::string & GetObjectName () const
 
- Public Member Functions inherited from itk::LightObject
Pointer Clone () const
 
virtual void Delete ()
 
virtual int GetReferenceCount () const
 
void Print (std::ostream &os, Indent indent=0) const
 
- Static Public Member Functions inherited from itk::Object
static bool GetGlobalWarningDisplay ()
 
static void GlobalWarningDisplayOff ()
 
static void GlobalWarningDisplayOn ()
 
static Pointer New ()
 
static void SetGlobalWarningDisplay (bool val)
 
- Static Public Member Functions inherited from itk::LightObject
static void BreakOnError ()
 
static Pointer New ()
 
- Static Public Attributes inherited from itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >
static constexpr unsigned int SpaceDimension = NDimensions
 
static constexpr unsigned int SplineOrder = VSplineOrder
 
- Static Public Attributes inherited from itk::Transform< TParametersValueType, NDimensions, NDimensions >
static constexpr unsigned int InputSpaceDimension
 
static constexpr unsigned int OutputSpaceDimension
 
- Protected Member Functions inherited from itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >
 BSplineBaseTransform ()
 
 ~BSplineBaseTransform () override=default
 
virtual void SetWeightsFunction (WeightsFunctionType *_arg)
 
virtual WeightsFunctionTypeGetModifiableWeightsFunction ()
 
virtual const WeightsFunctionTypeGetWeightsFunction () const
 
void WrapAsImages ()
 
void SetFixedParametersFromTransformDomainInformation () const
 
- Protected Member Functions inherited from itk::Transform< TParametersValueType, NDimensions, NDimensions >
LightObject::Pointer InternalClone () const override
 
 Transform ()
 
 Transform (NumberOfParametersType numberOfParameters)
 
 ~Transform () override=default
 
OutputDiffusionTensor3DType PreservationOfPrincipalDirectionDiffusionTensor3DReorientation (const InputDiffusionTensor3DType &, const InverseJacobianPositionType &) const
 
- Protected Member Functions inherited from itk::TransformBaseTemplate< TParametersValueType >
 TransformBaseTemplate ()=default
 
 ~TransformBaseTemplate () override=default
 
- Protected Member Functions inherited from itk::Object
 Object ()
 
 ~Object () override
 
bool PrintObservers (std::ostream &os, Indent indent) const
 
virtual void SetTimeStamp (const TimeStamp &timeStamp)
 
- Protected Member Functions inherited from itk::LightObject
 LightObject ()
 
virtual void PrintHeader (std::ostream &os, Indent indent) const
 
virtual void PrintTrailer (std::ostream &os, Indent indent) const
 
virtual ~LightObject ()
 
- Protected Attributes inherited from itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >
CoefficientImageArray m_CoefficientImages
 
ParametersType m_InternalParametersBuffer
 
WeightsFunctionType::Pointer m_WeightsFunction
 
- Protected Attributes inherited from itk::Transform< TParametersValueType, NDimensions, NDimensions >
ParametersType m_Parameters
 
FixedParametersType m_FixedParameters
 
DirectionChangeMatrix m_DirectionChange
 
- Protected Attributes inherited from itk::LightObject
std::atomic< int > m_ReferenceCount
 

Detailed Description

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
class itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >

Deformable transform using a BSpline representation.

Note
BSplineTransform is a newer version of this class, and it is preferred.

This class encapsulates a deformable transform of points from one N-dimensional space to another N-dimensional space. The deformation field is modelled using B-splines. A deformation is defined on a sparse regular grid of control points $ \vec{\lambda}_j $ and is varied by defining a deformation $ \vec{g}(\vec{\lambda}_j) $ of each control point. The deformation $ D(\vec{x}) $ at any point $ \vec{x} $ is obtained by using a B-spline interpolation kernel.

The deformation field grid is defined by a user specified GridRegion, GridSpacing and GridOrigin. Each grid/control point has associated with it N deformation coefficients $ \vec{\delta}_j $, representing the N directional components of the deformation. Deformation outside the grid plus support region for the BSpline interpolation is assumed to be zero.

Additionally, the user can specified an addition bulk transform $ B $ such that the transformed point is given by:

\[ \vec{y} = B(\vec{x}) + D(\vec{x}) \]

The parameters for this transform is an N x N-D grid of spline coefficients. The user specifies the parameters as one flat array: each N-D grid is represented by an array in the same way an N-D image is represented in the buffer; the N arrays are then concatenated together on form a single array.

For efficiency, this transform does not make a copy of the parameters. It only keeps a pointer to the input parameters and assumes that the memory is managed by the caller.

The following illustrates the typical usage of this class:

using TransformType = BSplineDeformableTransform<double,2,3>;
TransformType::Pointer transform = TransformType::New();
transform->SetGridRegion( region );
transform->SetGridSpacing( spacing );
transform->SetGridOrigin( origin );
// NB: the region must be set first before setting the parameters
TransformType::ParametersType parameters( transform->GetNumberOfParameters() );
// Fill the parameters with values
transform->SetParameters( parameters )
outputPoint = transform->TransformPoint( inputPoint );

An alternative way to set the B-spline coefficients is via array of images. The grid region, spacing and origin information is taken directly from the first image. It is assumed that the subsequent images are the same buffered region. The following illustrates the API:

TransformType::ImageConstPointer images[2];
// Fill the images up with values
transform->SetCoefficientImages( images );
outputPoint = transform->TransformPoint( inputPoint );

Warning: use either the SetParameters() or SetCoefficientImages() API. Mixing the two modes may results in unexpected results.

The class is templated coordinate representation type (float or double), the space dimension and the spline order.

See also
BSplineTransform
ITK Sphinx Examples:
Examples
SphinxExamples/src/Core/Transform/GlobalRegistrationTwoImagesBSpline/Code.cxx.

Definition at line 113 of file itkBSplineDeformableTransform.h.

Member Typedef Documentation

◆ BulkTransformPointer

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::BulkTransformPointer = typename BulkTransformType::ConstPointer

Standard scalar type for this class.

Definition at line 308 of file itkBSplineDeformableTransform.h.

◆ BulkTransformType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::BulkTransformType = Transform<TParametersValueType, Self::SpaceDimension, Self::SpaceDimension>

Standard scalar type for this class.

Definition at line 307 of file itkBSplineDeformableTransform.h.

◆ CoefficientImageArray

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::CoefficientImageArray = typename Superclass::CoefficientImageArray

Standard scalar type for this class.

Definition at line 212 of file itkBSplineDeformableTransform.h.

◆ ConstPointer

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ConstPointer = SmartPointer<const Self>

Definition at line 123 of file itkBSplineDeformableTransform.h.

◆ ContinuousIndexType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ContinuousIndexType = typename Superclass::ContinuousIndexType

Standard scalar type for this class.

Definition at line 241 of file itkBSplineDeformableTransform.h.

◆ DirectionType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::DirectionType = typename Superclass::DirectionType

Standard scalar type for this class.

Definition at line 234 of file itkBSplineDeformableTransform.h.

◆ FixedParametersType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::FixedParametersType = typename Superclass::FixedParametersType

Standard scalar type for this class.

Definition at line 161 of file itkBSplineDeformableTransform.h.

◆ FixedParametersValueType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::FixedParametersValueType = typename Superclass::FixedParametersValueType

Standard scalar type for this class.

Definition at line 162 of file itkBSplineDeformableTransform.h.

◆ ImagePointer

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ImagePointer = typename Superclass::ImagePointer

Standard scalar type for this class.

Definition at line 211 of file itkBSplineDeformableTransform.h.

◆ ImageType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ImageType = typename Superclass::ImageType

Parameters as SpaceDimension number of images.

Definition at line 210 of file itkBSplineDeformableTransform.h.

◆ IndexType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::IndexType = typename Superclass::IndexType

Standard scalar type for this class.

Definition at line 231 of file itkBSplineDeformableTransform.h.

◆ InputCovariantVectorType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::InputCovariantVectorType = typename Superclass::InputCovariantVectorType

Standard covariant vector type for this class.

Definition at line 177 of file itkBSplineDeformableTransform.h.

◆ InputPointType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::InputPointType = Point<TParametersValueType, Self::SpaceDimension>

Standard coordinate point type for this class.

Definition at line 185 of file itkBSplineDeformableTransform.h.

◆ InputVectorType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::InputVectorType = typename Superclass::InputVectorType

Standard vector type for this class.

Definition at line 173 of file itkBSplineDeformableTransform.h.

◆ InputVnlVectorType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::InputVnlVectorType = typename Superclass::InputVnlVectorType

Standard vnl_vector type for this class.

Definition at line 181 of file itkBSplineDeformableTransform.h.

◆ InverseJacobianPositionType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::InverseJacobianPositionType = typename Superclass::InverseJacobianPositionType

Standard scalar type for this class.

Definition at line 167 of file itkBSplineDeformableTransform.h.

◆ JacobianPositionType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::JacobianPositionType = typename Superclass::JacobianPositionType

Standard scalar type for this class.

Definition at line 166 of file itkBSplineDeformableTransform.h.

◆ JacobianType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::JacobianType = typename Superclass::JacobianType

Standard Jacobian container.

Definition at line 165 of file itkBSplineDeformableTransform.h.

◆ MeshSizeType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::MeshSizeType = typename Superclass::MeshSizeType

Standard scalar type for this class.

Definition at line 277 of file itkBSplineDeformableTransform.h.

◆ NumberOfParametersType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::NumberOfParametersType = typename Superclass::NumberOfParametersType

The number of parameters defining this transform.

Definition at line 170 of file itkBSplineDeformableTransform.h.

◆ OriginType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::OriginType = typename Superclass::OriginType

Standard scalar type for this class.

Definition at line 235 of file itkBSplineDeformableTransform.h.

◆ OutputCovariantVectorType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::OutputCovariantVectorType = typename Superclass::OutputCovariantVectorType

Standard scalar type for this class.

Definition at line 178 of file itkBSplineDeformableTransform.h.

◆ OutputPointType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::OutputPointType = Point<TParametersValueType, Self::SpaceDimension>

Standard scalar type for this class.

Definition at line 186 of file itkBSplineDeformableTransform.h.

◆ OutputVectorType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::OutputVectorType = typename Superclass::OutputVectorType

Standard scalar type for this class.

Definition at line 174 of file itkBSplineDeformableTransform.h.

◆ OutputVnlVectorType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::OutputVnlVectorType = typename Superclass::OutputVnlVectorType

Standard scalar type for this class.

Definition at line 182 of file itkBSplineDeformableTransform.h.

◆ ParameterIndexArrayType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ParameterIndexArrayType = typename Superclass::ParameterIndexArrayType

Parameter index array type.

Definition at line 244 of file itkBSplineDeformableTransform.h.

◆ ParametersType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ParametersType = typename Superclass::ParametersType

Standard parameters container.

Definition at line 159 of file itkBSplineDeformableTransform.h.

◆ ParametersValueType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ParametersValueType = typename Superclass::ParametersValueType

Standard scalar type for this class.

Definition at line 160 of file itkBSplineDeformableTransform.h.

◆ PhysicalDimensionsType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::PhysicalDimensionsType = typename Superclass::SpacingType

Standard scalar type for this class.

Definition at line 274 of file itkBSplineDeformableTransform.h.

◆ PixelType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::PixelType = typename Superclass::PixelType

Standard scalar type for this class.

Definition at line 275 of file itkBSplineDeformableTransform.h.

◆ Pointer

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::Pointer = SmartPointer<Self>

Definition at line 122 of file itkBSplineDeformableTransform.h.

◆ RegionType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::RegionType = typename Superclass::RegionType

Typedefs for specifying the extent of the grid.

Definition at line 229 of file itkBSplineDeformableTransform.h.

◆ ScalarType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ScalarType = TParametersValueType

Standard scalar type for this class.

Definition at line 156 of file itkBSplineDeformableTransform.h.

◆ Self

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::Self = BSplineDeformableTransform

Standard class type aliases.

Definition at line 120 of file itkBSplineDeformableTransform.h.

◆ SizeType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SizeType = typename Superclass::SizeType

Standard scalar type for this class.

Definition at line 232 of file itkBSplineDeformableTransform.h.

◆ SpacingType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SpacingType = typename Superclass::SpacingType

Standard scalar type for this class.

Definition at line 233 of file itkBSplineDeformableTransform.h.

◆ Superclass

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::Superclass = BSplineBaseTransform<TParametersValueType, NDimensions, VSplineOrder>

Definition at line 121 of file itkBSplineDeformableTransform.h.

◆ WeightsFunctionType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::WeightsFunctionType = typename Superclass::WeightsFunctionType

Interpolation weights function type.

Definition at line 238 of file itkBSplineDeformableTransform.h.

◆ WeightsType

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
using itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::WeightsType = typename Superclass::WeightsType

Standard scalar type for this class.

Definition at line 240 of file itkBSplineDeformableTransform.h.

Constructor & Destructor Documentation

◆ BSplineDeformableTransform()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::BSplineDeformableTransform ( )
protected

Standard scalar type for this class.

◆ ~BSplineDeformableTransform()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::~BSplineDeformableTransform ( )
overrideprotecteddefault

Standard scalar type for this class.

Member Function Documentation

◆ ComputeJacobianWithRespectToParameters()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::ComputeJacobianWithRespectToParameters ( const InputPointType ,
JacobianType  
) const
overridevirtual

Standard scalar type for this class.

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ CreateAnother()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
::itk::LightObject::Pointer itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::CreateAnother ( ) const
inlineoverridevirtual

Standard scalar type for this class.

Reimplemented from itk::Object.

Definition at line 132 of file itkBSplineDeformableTransform.h.

References itk::SmartPointer< TObjectType >::GetPointer().

◆ GetBulkTransform()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual const BulkTransformType* itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetBulkTransform ( ) const
virtual

Standard scalar type for this class.

◆ GetGridDirection()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual DirectionType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetGridDirection ( ) const
virtual

Function to retrieve the transform domain direction.

◆ GetGridOrigin()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual OriginType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetGridOrigin ( ) const
virtual

Function to retrieve the transform domain origin.

◆ GetGridRegion()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual RegionType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetGridRegion ( ) const
virtual

Function to retrieve the transform domain mesh size.

◆ GetGridSpacing()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual SpacingType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetGridSpacing ( ) const
virtual

This method retrieve the grid spacing or resolution.

◆ GetNameOfClass()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual const char* itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetNameOfClass ( ) const
virtual

Run-time type information (and related methods).

Reimplemented from itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ GetNumberOfParameters()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
NumberOfParametersType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetNumberOfParameters ( ) const
overridevirtual

Return the number of parameters that completely define the Transfom

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ GetNumberOfParametersPerDimension()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
NumberOfParametersType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetNumberOfParametersPerDimension ( ) const
overridevirtual

Return the number of parameters per dimension

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ GetValidRegion()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual const RegionType& itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::GetValidRegion ( ) const
virtual

Return the region of the grid wholly within the support region

◆ InsideValidRegion()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
bool itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::InsideValidRegion ( ContinuousIndexType ) const
overrideprivatevirtual

Check if a continuous index is inside the valid region.

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ itkCloneMacro()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::itkCloneMacro ( Self  )

implement type-specific clone method

◆ New()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
static Pointer itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::New ( )
static

New macro for creation of through the object factory.

◆ PrintSelf()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::PrintSelf ( std::ostream &  os,
Indent  indent 
) const
overrideprotectedvirtual

◆ SetBulkTransform()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetBulkTransform ( const BulkTransformType _arg)
virtual

This method specifies the bulk transform to be applied. The default is the identity transform.

◆ SetCoefficientImageInformationFromFixedParameters()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetCoefficientImageInformationFromFixedParameters ( )
overrideprivatevirtual

Construct control point grid size from transform domain information

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ SetCoefficientImages()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetCoefficientImages ( const CoefficientImageArray images)
overridevirtual

Set the array of coefficient images.

This is an alternative API for setting the BSpline coefficients as an array of SpaceDimension images. The fixed parameters are taken from the first image. It is assumed that the buffered region of all the subsequent images are the same as the first image. Note that no error checking is done.

Warning: use either the SetParameters() or SetCoefficientImages() API. Mixing the two modes may results in unexpected results.

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ SetFixedParameters()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetFixedParameters ( const FixedParametersType passedParameters)
overridevirtual

This method sets the fixed parameters of the transform. For a BSpline deformation transform, the parameters are the following: Grid Size, Grid Origin, and Grid Spacing

The fixed parameters are the three times the size of the templated dimensions. This function has the effect of make the following calls: transform->SetGridSpacing( spacing ); transform->SetGridOrigin( origin ); transform->SetGridDirection( direction ); transform->SetGridRegion( bsplineRegion );

This function was added to allow the transform to work with the itkTransformReader/Writer I/O filters.

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ SetFixedParametersGridDirectionFromTransformDomainInformation()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetFixedParametersGridDirectionFromTransformDomainInformation ( ) const
overrideprivatevirtual

Construct control point grid direction from transform domain information

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ SetFixedParametersGridOriginFromTransformDomainInformation()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetFixedParametersGridOriginFromTransformDomainInformation ( ) const
overrideprivatevirtual

Construct control point grid origin from transform domain information

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ SetFixedParametersGridSizeFromTransformDomainInformation()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetFixedParametersGridSizeFromTransformDomainInformation ( ) const
overrideprivatevirtual

Construct control point grid size from transform domain information

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ SetFixedParametersGridSpacingFromTransformDomainInformation()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetFixedParametersGridSpacingFromTransformDomainInformation ( ) const
overrideprivatevirtual

Construct control point grid spacing from transform domain information

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ SetGridDirection()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetGridDirection ( const DirectionType )
virtual

Function to specify the transform domain direction.

◆ SetGridOrigin()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetGridOrigin ( const OriginType )
virtual

Function to specify the transform domain origin.

◆ SetGridRegion()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetGridRegion ( const RegionType )
virtual

Function to specify the transform domain mesh size.

◆ SetGridSpacing()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
virtual void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SetGridSpacing ( const SpacingType )
virtual

This method specifies the grid spacing or resolution.

◆ TransformPoint()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::TransformPoint ( const InputPointType inputPoint,
OutputPointType outputPoint,
WeightsType weights,
ParameterIndexArrayType indices,
bool &  inside 
) const
overridevirtual

Standard scalar type for this class.

Implements itk::BSplineBaseTransform< TParametersValueType, NDimensions, VSplineOrder >.

◆ UpdateValidGridRegion()

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
void itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::UpdateValidGridRegion ( )
private

Standard scalar type for this class.

Member Data Documentation

◆ m_BulkTransform

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
BulkTransformPointer itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_BulkTransform
private

The bulk transform.

Definition at line 366 of file itkBSplineDeformableTransform.h.

◆ m_GridDirection

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
const DirectionType& itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_GridDirection
private

Standard scalar type for this class.

Definition at line 363 of file itkBSplineDeformableTransform.h.

◆ m_GridOrigin

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
const OriginType& itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_GridOrigin
private

Standard scalar type for this class.

Definition at line 361 of file itkBSplineDeformableTransform.h.

◆ m_GridRegion

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
const RegionType& itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_GridRegion
private

The variables defining the coefficient grid domain for the InternalParametersBuffer are taken from the m_CoefficientImages[0] image, and must be kept in sync with them. by using references to that instance, this is more naturally enforced and does not introduce a speed penalty of dereferencing through the pointers (although it does enforce some internal class synchronization).

Definition at line 360 of file itkBSplineDeformableTransform.h.

◆ m_GridSpacing

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
const SpacingType& itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_GridSpacing
private

Standard scalar type for this class.

Definition at line 362 of file itkBSplineDeformableTransform.h.

◆ m_Offset

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
unsigned long itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_Offset
private

Variables defining the interpolation support region.

Definition at line 371 of file itkBSplineDeformableTransform.h.

◆ m_SplineOrderOdd

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
bool itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_SplineOrderOdd
private

Standard scalar type for this class.

Definition at line 372 of file itkBSplineDeformableTransform.h.

◆ m_ValidRegion

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
RegionType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_ValidRegion
private

Standard scalar type for this class.

Definition at line 368 of file itkBSplineDeformableTransform.h.

◆ m_ValidRegionFirst

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
IndexType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_ValidRegionFirst
private

Standard scalar type for this class.

Definition at line 374 of file itkBSplineDeformableTransform.h.

◆ m_ValidRegionLast

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
IndexType itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::m_ValidRegionLast
private

Standard scalar type for this class.

Definition at line 373 of file itkBSplineDeformableTransform.h.

◆ SpaceDimension

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
constexpr unsigned int itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SpaceDimension = NDimensions
staticconstexpr

Dimension of the domain space.

Definition at line 150 of file itkBSplineDeformableTransform.h.

◆ SplineOrder

template<typename TParametersValueType = double, unsigned int NDimensions = 3, unsigned int VSplineOrder = 3>
constexpr unsigned int itk::BSplineDeformableTransform< TParametersValueType, NDimensions, VSplineOrder >::SplineOrder = VSplineOrder
staticconstexpr

The BSpline order.

Definition at line 153 of file itkBSplineDeformableTransform.h.


The documentation for this class was generated from the following file: