NifTK  16.4.1 - 0798f20
CMIC's Translational Medical Imaging Platform
Classes | Public Types | Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType > Class Template Referenceabstract

Base class for breast mask MRI segmentation methods. More...

Inheritance diagram for itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >:
Inheritance graph
[legend]
Collaboration diagram for itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >:
Collaboration graph
[legend]

Classes

class  BIFIntensityAccessor
 
struct  larger_second
 

Public Types

enum  enumBreastSideType { BOTH_BREASTS, LEFT_BREAST, RIGHT_BREAST }
 Breast side. More...
 
typedef
BreastMaskSegmentationFromMRI 
Self
 
typedef Object Superclass
 
typedef SmartPointer< SelfPointer
 
typedef SmartPointer< const SelfConstPointer
 
typedef float RealType
 
typedef itk::Image
< InputPixelType,
ImageDimension > 
InternalImageType
 
typedef itk::Image< RealType,
SliceDimension > 
AxialImageType
 
typedef itk::Vector< RealType,
DataDimension > 
VectorType
 
typedef itk::Image< VectorType,
ParametricDimension > 
VectorImageType
 
typedef itk::PointSet
< VectorType,
ParametricDimension > 
PointSetType
 
typedef
PointSetType::PointsContainer 
PointsContainer
 
typedef PointsContainer::Iterator PointsIterator
 
typedef
PointSetType::PointDataContainer 
PointDataContainer
 
typedef
PointDataContainer::Iterator 
PointDataIterator
 
typedef
itk::ImageRegionIterator
< InternalImageType
IteratorType
 
typedef
itk::ImageRegionIteratorWithIndex
< InternalImageType
IteratorWithIndexType
 
typedef
itk::ImageSliceIteratorWithIndex
< InternalImageType
SliceIteratorType
 
typedef
itk::ImageLinearIteratorWithIndex
< InternalImageType
LineIteratorType
 
typedef itk::ImageDuplicator
< InternalImageType
DuplicatorType
 
typedef itk::Image
< InputPixelType,
SliceDimension > 
InputSliceType
 
typedef
itk::BasicImageFeaturesImageFilter
< InputSliceType,
InputSliceType
BasicImageFeaturesFilterType
 
typedef
itk::SliceBySliceImageFilter
< InternalImageType,
InternalImageType
SliceBySliceImageFilterType
 
typedef
itk::RegionGrowSurfacePoints
< InternalImageType,
InternalImageType
ConnectedSurfaceVoxelFilterType
 
typedef
itk::CurvatureAnisotropicDiffusionImageFilter
< InternalImageType,
InternalImageType
SmoothingFilterType
 
typedef
itk::GradientMagnitudeRecursiveGaussianImageFilter
< InternalImageType,
InternalImageType
GradientFilterType
 
typedef
itk::SigmoidImageFilter
< InternalImageType,
InternalImageType
SigmoidFilterType
 
typedef
itk::FastMarchingImageFilter
< InternalImageType,
InternalImageType
FastMarchingFilterType
 
typedef
itk::BinaryThresholdImageFilter
< InternalImageType,
InternalImageType
ThresholdingFilterType
 
typedef
itk::LewisGriffinRecursiveGaussianImageFilter
< InternalImageType,
InternalImageType
DerivativeFilterType
 
typedef
DerivativeFilterType::Pointer 
DerivativeFilterPointer
 
typedef
itk::MaximumImageFilter
< InternalImageType,
InternalImageType
MaxImageFilterType
 
typedef
itk::ConnectedThresholdImageFilter
< InternalImageType,
InternalImageType
ConnectedFilterType
 

Public Member Functions

virtual const char * GetClassName () const
 
 itkStaticConstMacro (SliceDimension, unsigned int, 2)
 
 itkStaticConstMacro (ParametricDimension, unsigned int, 2)
 
 itkStaticConstMacro (DataDimension, unsigned int, 1)
 
void SetVerbose (bool flag)
 
void SetSmooth (bool flag)
 
void SetLeftBreast (bool flag)
 
void SetRightBreast (bool flag)
 
void SetExtInitialPect (bool flag)
 
void SetRegionGrowX (int coord)
 
void SetRegionGrowY (int coord)
 
void SetRegionGrowZ (int coord)
 
void SetBackgroundThreshold (float threshold)
 
void SetFinalSegmThreshold (float threshold)
 
void SetSigmaInMM (float sigma)
 
void SetMarchingK1 (float k1)
 
void SetMarchingK2 (float k2)
 
void SetMarchingTime (float t)
 
void SetCoilCropDistance (float cropDist)
 
void SetCropDistancePosteriorToMidSternum (float fDistIn)
 
void SetOutputBIFS (std::string fn)
 
void SetSigmaBIF (float sig)
 
void SetOutputSmoothedStructural (std::string fn)
 
void SetOutputSmoothedFatSat (std::string fn)
 
void SetOutputClosedStructural (std::string fn)
 
void SetOutputHistogram (std::string fn)
 
void SetOutputFit (std::string fn)
 
void SetOutputCDF (std::string fn)
 
void SetOutputImageMax (std::string fn)
 
void SetOutputImageMaxClosed (std::string fn)
 
void SetOutputBackground (std::string fn)
 
void SetOutputChestPoints (std::string fn)
 
void SetPectoralControlPointSpacing (float d)
 
void SetOutputPectoralMask (std::string fn)
 
void SetOutputPecSurfaceMask (std::string fn)
 
void SetOutputGradientMagImage (std::string fn)
 
void SetOutputSpeedImage (std::string fn)
 
void SetOutputFastMarchingImage (std::string fn)
 
void SetOutputPectoralSurf (std::string fn)
 
void SetExcludeAxilla (bool flag)
 
void SetCropFit (bool flag)
 
void SetOutputBreastFittedSurfMask (std::string fn)
 
void SetOutputVTKSurface (std::string fn)
 
void SetOutputSkinElevationMap (std::string fn)
 
void SetOutputSkinSurfaceNoBreasts (std::string fn)
 
void SetStructuralImage (typename InternalImageType::Pointer image)
 
void SetFatSatImage (typename InternalImageType::Pointer image)
 
void SetBIFImage (typename InternalImageType::Pointer image)
 
InternalImageType::IndexType GetLeftNippleIndex (void)
 
InternalImageType::IndexType GetRightNippleIndex (void)
 
InternalImageType::IndexType GetMidSternumIndex (void)
 
virtual void Execute (void)=0
 Execute the segmentation - must be implemented in derived class. More...
 
InternalImageType::Pointer GetSegmentedImage (void)
 
void WriteSegmentationToAFile (std::string fileOutput)
 Write the segmented image to a file. More...
 

Protected Member Functions

 BreastMaskSegmentationFromMRI ()
 Constructor. More...
 
virtual ~BreastMaskSegmentationFromMRI ()
 Destructor. More...
 
virtual void Initialise (void)
 Initialise the segmentor. More...
 
virtual void CreateBIFs (void)
 Create the BIF Image. More...
 
void SmoothTheInputImages (void)
 Smooth the structural and FatSat images. More...
 
InternalImageType::Pointer ScanLineMaxima (typename InternalImageType::Pointer image, typename InternalImageType::RegionType region, unsigned int direction, bool flgForward)
 Scan an image in a particular direction and replace voxels with scanned maximum intensity. More...
 
InternalImageType::Pointer GreyScaleCloseImage (typename InternalImageType::Pointer image, typename InternalImageType::RegionType region, unsigned int direction, const std::string label)
 Scan an image in a particular direction and replace voxels with closed intensities. More...
 
InternalImageType::Pointer GreyScaleCloseImage (typename InternalImageType::Pointer image, typename InternalImageType::RegionType region, const char *strSide)
 Scan an image in all directions and replace voxels with closed intensities. More...
 
void GreyScaleClosing (void)
 Scan rows and columns in the image to fill in the center of the breast. More...
 
void CalculateTheMaximumImage (void)
 Calculate the maximum image. More...
 
void EnsureMaxImageHasOnlyPositiveIntensities (void)
 Ensure the maximum image contains only positive intensities. More...
 
void SmoothMaxImageToIncreaseSeparationOfTheBackground (void)
 Smooth the image to increase separation of the background. More...
 
void SegmentForegroundFromBackground (void)
 Segment the backgound using itkForegroundFromBackgroundImageThresholdCalculator. More...
 
void SegmentBackground (void)
 Segment the backgound using the maximum image histogram. More...
 
void ComputeElevationOfAnteriorSurface (bool flgCoilCrop=false)
 Compute a 2D map of the height of the patient's anterior skin surface. More...
 
InternalImageType::IndexType FindSurfacePoint (typename InternalImageType::IndexType idxNipple, float deltaXinMM, float deltaZinMM)
 Find a point in the surface offset from the nipple. More...
 
void FindBreastLandmarks (void)
 Find the nipple and mid-sternum landmarks. More...
 
PointSetType::Pointer SegmentThePectoralMuscle (RealType rYHeightOffset, unsigned long &iPointPec, bool flgIncludeNippleSeeds=false)
 Segment the Pectoral Muscle. More...
 
void CropTheMaskAccordingToEstimateOfCoilExtentInCoronalPlane (void)
 Discard anything not within the skin elevation mask. More...
 
void MaskWithBSplineBreastSurface (RealType rYHeightOffset)
 Discard anything not within a B-Spline fitted to the breast skin surface. More...
 
void MaskBreastWithSphere (void)
 Mask with a sphere centered on each breast. More...
 
void SmoothMask (void)
 Smooth the mask and threshold to round corners etc. More...
 
void ExtractLargestObject (enumBreastSideType breastSide)
 Extract the largest object. More...
 
double DistanceBetweenVoxels (typename InternalImageType::IndexType p, typename InternalImageType::IndexType q)
 
std::string ModifySuffix (std::string filename, std::string strInsertBeforeSuffix)
 
std::string GetBreastSide (std::string &fileOutput, enumBreastSideType breastSide)
 
InternalImageType::Pointer GetBreastSide (typename InternalImageType::Pointer inImage, enumBreastSideType breastSide)
 
bool WriteImageToFile (std::string &fileOutput, const char *description, typename InternalImageType::Pointer image, enumBreastSideType breastSide)
 
bool WriteImageToFile (std::string &fileOutput, const char *description, typename InternalImageType::Pointer image, bool flgLeft=false, bool flgRight=false)
 
bool WriteBinaryImageToUCharFile (std::string &fileOutput, const char *description, typename InternalImageType::Pointer image, enumBreastSideType breastSide)
 
bool WriteBinaryImageToUCharFile (std::string &fileOutput, const char *description, typename InternalImageType::Pointer image, bool flgLeft, bool flgRight)
 
bool WriteBinaryImageToUCharFileOrVTKSurfaceFile (std::string &fileOutput, const char *description, typename InternalImageType::Pointer image, bool flgLeft, bool flgRight)
 Based on the file extension it will be decided wheter a vtk surface is written or an image is saved. More...
 
void WriteHistogramToFile (std::string fileOutput, vnl_vector< double > &xHistIntensity, vnl_vector< double > &yHistFrequency, unsigned int nBins)
 
void polyDataInfo (vtkPolyData *polyData)
 
void WriteImageToVTKSurfaceFile (typename InternalImageType::Pointer image, std::string &fileOutput, enumBreastSideType breastSide, bool flgVerbose, float finalSegmThreshold)
 
InternalImageType::Pointer MaskImageFromBSplineFittedSurface (const typename PointSetType::Pointer &pointSet, const typename InternalImageType::RegionType &region, const typename InternalImageType::PointType &origin, const typename InternalImageType::SpacingType &spacing, const typename InternalImageType::DirectionType &direction, const RealType rYHeightOffset, const int splineOrder, const RealType controlPointSpacingInMM, const int numOfLevels, bool correctSurfaceOffest)
 

Protected Attributes

bool flgVerbose
 
bool flgXML
 
bool flgSmooth
 
bool flgLeft
 
bool flgRight
 
bool flgExtInitialPect
 
bool flgRegGrowXcoord
 
bool flgRegGrowYcoord
 
bool flgRegGrowZcoord
 
bool flgCropWithFittedSurface
 
bool flgExcludeAxilla
 
unsigned int i
 
int regGrowXcoord
 
int regGrowYcoord
 
int regGrowZcoord
 
float maxIntensity
 
float minIntensity
 
float bgndThresholdProb
 
float finalSegmThreshold
 
float sigmaInMM
 
float fMarchingK1
 
float fMarchingK2
 
float fMarchingTime
 
float sigmaBIF
 
float coilCropDistance
 
float cropDistPosteriorToMidSternum
 
float pecControlPointSpacing
 
std::string fileOutputBIFs
 
std::string fileOutputSmoothedStructural
 
std::string fileOutputSmoothedFatSat
 
std::string fileOutputClosedStructural
 
std::string fileOutputCombinedHistogram
 
std::string fileOutputRayleigh
 
std::string fileOutputFreqLessBgndCDF
 
std::string fileOutputMaxImage
 
std::string fileOutputMaxClosedImage
 
std::string fileOutputBackground
 
std::string fileOutputPectoralSurfaceMask
 
std::string fileOutputChestPoints
 
std::string fileOutputPectoral
 
std::string fileOutputGradientMagImage
 
std::string fileOutputSpeedImage
 
std::string fileOutputFastMarchingImage
 
std::string fileOutputPectoralSurfaceVoxels
 
std::string fileOutputFittedBreastMask
 
std::string fileOutputVTKSurface
 
std::string fileOutputSkinElevationMap
 
std::string fileOutputSkinSurfaceNoBreasts
 
InternalImageType::Pointer imStructural
 
InternalImageType::Pointer imFatSat
 
InternalImageType::Pointer imBIFs
 
InternalImageType::Pointer imSpeedFuncInputImage
 
InternalImageType::Pointer imMaximum
 
InternalImageType::Pointer imMaxClosed
 
InternalImageType::Pointer imPectoralVoxels
 
InternalImageType::Pointer imPectoralSurfaceVoxels
 
InternalImageType::Pointer imChestSurfaceVoxels
 
InternalImageType::Pointer imSegmented
 
InternalImageType::Pointer imTmp
 
AxialImageType::Pointer imSkinElevationMap
 
InternalImageType::RegionType m_LeftLateralRegion
 The left side of the image. More...
 
InternalImageType::RegionType m_RightLateralRegion
 
InternalImageType::IndexType idxMidSternum
 Breast Landmarks. More...
 
InternalImageType::IndexType idxNippleRight
 
InternalImageType::IndexType idxNippleLeft
 
InternalImageType::IndexType idxLeftBreastMidPoint
 Landmarks used by the segmentation. More...
 
InternalImageType::IndexType idxRightBreastMidPoint
 
InternalImageType::IndexType idxLeftPosterior
 
InternalImageType::IndexType idxRightPosterior
 
InternalImageType::IndexType idxAreolarRight [4]
 
InternalImageType::IndexType idxAreolarLeft [4]
 

Detailed Description

template<const unsigned int ImageDimension, class InputPixelType>
class itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >

Base class for breast mask MRI segmentation methods.

This class defines the common methods used by variations of the breast mask segmentation.

Member Typedef Documentation

template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::Image<RealType, SliceDimension> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::AxialImageType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::BasicImageFeaturesImageFilter< InputSliceType, InputSliceType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::BasicImageFeaturesFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::ConnectedThresholdImageFilter< InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::ConnectedFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::RegionGrowSurfacePoints< InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::ConnectedSurfaceVoxelFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef SmartPointer<const Self> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::ConstPointer
template<const unsigned int ImageDimension, class InputPixelType >
typedef DerivativeFilterType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::DerivativeFilterPointer
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::LewisGriffinRecursiveGaussianImageFilter< InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::DerivativeFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::ImageDuplicator< InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::DuplicatorType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::FastMarchingImageFilter< InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::FastMarchingFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::GradientMagnitudeRecursiveGaussianImageFilter< InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GradientFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::Image<InputPixelType, SliceDimension> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::InputSliceType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::Image<InputPixelType, ImageDimension> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::InternalImageType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::ImageRegionIterator< InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::IteratorType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::ImageRegionIteratorWithIndex<InternalImageType> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::IteratorWithIndexType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::ImageLinearIteratorWithIndex< InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::LineIteratorType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::MaximumImageFilter<InternalImageType, InternalImageType> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::MaxImageFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef PointSetType::PointDataContainer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::PointDataContainer
template<const unsigned int ImageDimension, class InputPixelType >
typedef PointDataContainer::Iterator itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::PointDataIterator
template<const unsigned int ImageDimension, class InputPixelType >
typedef SmartPointer<Self> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::Pointer
template<const unsigned int ImageDimension, class InputPixelType >
typedef PointSetType::PointsContainer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::PointsContainer
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::PointSet<VectorType, ParametricDimension> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::PointSetType
template<const unsigned int ImageDimension, class InputPixelType >
typedef PointsContainer::Iterator itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::PointsIterator
template<const unsigned int ImageDimension, class InputPixelType >
typedef float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::RealType
template<const unsigned int ImageDimension, class InputPixelType >
typedef BreastMaskSegmentationFromMRI itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::Self
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::SigmoidImageFilter<InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SigmoidFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::SliceBySliceImageFilter< InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SliceBySliceImageFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::ImageSliceIteratorWithIndex< InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SliceIteratorType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::CurvatureAnisotropicDiffusionImageFilter< InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SmoothingFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef Object itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::Superclass
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::BinaryThresholdImageFilter< InternalImageType, InternalImageType > itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::ThresholdingFilterType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::Image<VectorType, ParametricDimension> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::VectorImageType
template<const unsigned int ImageDimension, class InputPixelType >
typedef itk::Vector<RealType, DataDimension> itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::VectorType

Member Enumeration Documentation

template<const unsigned int ImageDimension, class InputPixelType >
enum itk::BreastMaskSegmentationFromMRI::enumBreastSideType

Breast side.

Enumerator
BOTH_BREASTS 
LEFT_BREAST 
RIGHT_BREAST 

Constructor & Destructor Documentation

template<const unsigned int ImageDimension, class InputPixelType >
itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::BreastMaskSegmentationFromMRI ( )
protected

Constructor.

template<const unsigned int ImageDimension, class InputPixelType >
virtual itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::~BreastMaskSegmentationFromMRI ( )
protectedvirtual

Destructor.

Member Function Documentation

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::CalculateTheMaximumImage ( void  )
protected

Calculate the maximum image.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::ComputeElevationOfAnteriorSurface ( bool  flgCoilCrop = false)
protected

Compute a 2D map of the height of the patient's anterior skin surface.

template<const unsigned int ImageDimension, class InputPixelType >
virtual void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::CreateBIFs ( void  )
protectedvirtual

Create the BIF Image.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::CropTheMaskAccordingToEstimateOfCoilExtentInCoronalPlane ( void  )
protected

Discard anything not within the skin elevation mask.

template<const unsigned int ImageDimension, class InputPixelType >
double itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::DistanceBetweenVoxels ( typename InternalImageType::IndexType  p,
typename InternalImageType::IndexType  q 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::EnsureMaxImageHasOnlyPositiveIntensities ( void  )
protected

Ensure the maximum image contains only positive intensities.

template<const unsigned int ImageDimension, class InputPixelType >
virtual void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::Execute ( void  )
pure virtual
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::ExtractLargestObject ( enumBreastSideType  breastSide)
protected

Extract the largest object.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::FindBreastLandmarks ( void  )
protected

Find the nipple and mid-sternum landmarks.

template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::FindSurfacePoint ( typename InternalImageType::IndexType  idxNipple,
float  deltaXinMM,
float  deltaZinMM 
)
protected

Find a point in the surface offset from the nipple.

template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GetBreastSide ( std::string fileOutput,
enumBreastSideType  breastSide 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GetBreastSide ( typename InternalImageType::Pointer  inImage,
enumBreastSideType  breastSide 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
virtual const char* itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GetClassName ( ) const
virtual
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GetLeftNippleIndex ( void  )
inline
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GetMidSternumIndex ( void  )
inline
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GetRightNippleIndex ( void  )
inline
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GetSegmentedImage ( void  )
inline
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GreyScaleCloseImage ( typename InternalImageType::Pointer  image,
typename InternalImageType::RegionType  region,
unsigned int  direction,
const std::string  label 
)
protected

Scan an image in a particular direction and replace voxels with closed intensities.

template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GreyScaleCloseImage ( typename InternalImageType::Pointer  image,
typename InternalImageType::RegionType  region,
const char *  strSide 
)
protected

Scan an image in all directions and replace voxels with closed intensities.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::GreyScaleClosing ( void  )
protected

Scan rows and columns in the image to fill in the center of the breast.

template<const unsigned int ImageDimension, class InputPixelType >
virtual void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::Initialise ( void  )
protectedvirtual

Initialise the segmentor.

template<const unsigned int ImageDimension, class InputPixelType >
itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::itkStaticConstMacro ( SliceDimension  ,
unsigned  int,
 
)
template<const unsigned int ImageDimension, class InputPixelType >
itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::itkStaticConstMacro ( ParametricDimension  ,
unsigned  int,
 
)
template<const unsigned int ImageDimension, class InputPixelType >
itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::itkStaticConstMacro ( DataDimension  ,
unsigned  int,
 
)
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::MaskBreastWithSphere ( void  )
protected

Mask with a sphere centered on each breast.

template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::MaskImageFromBSplineFittedSurface ( const typename PointSetType::Pointer &  pointSet,
const typename InternalImageType::RegionType region,
const typename InternalImageType::PointType &  origin,
const typename InternalImageType::SpacingType &  spacing,
const typename InternalImageType::DirectionType &  direction,
const RealType  rYHeightOffset,
const int  splineOrder,
const RealType  controlPointSpacingInMM,
const int  numOfLevels,
bool  correctSurfaceOffest 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::MaskWithBSplineBreastSurface ( RealType  rYHeightOffset)
protected

Discard anything not within a B-Spline fitted to the breast skin surface.

template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::ModifySuffix ( std::string  filename,
std::string  strInsertBeforeSuffix 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::polyDataInfo ( vtkPolyData *  polyData)
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::ScanLineMaxima ( typename InternalImageType::Pointer  image,
typename InternalImageType::RegionType  region,
unsigned int  direction,
bool  flgForward 
)
protected

Scan an image in a particular direction and replace voxels with scanned maximum intensity.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SegmentBackground ( void  )
protected

Segment the backgound using the maximum image histogram.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SegmentForegroundFromBackground ( void  )
protected

Segment the backgound using itkForegroundFromBackgroundImageThresholdCalculator.

template<const unsigned int ImageDimension, class InputPixelType >
PointSetType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SegmentThePectoralMuscle ( RealType  rYHeightOffset,
unsigned long &  iPointPec,
bool  flgIncludeNippleSeeds = false 
)
protected

Segment the Pectoral Muscle.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetBackgroundThreshold ( float  threshold)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetBIFImage ( typename InternalImageType::Pointer  image)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetCoilCropDistance ( float  cropDist)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetCropDistancePosteriorToMidSternum ( float  fDistIn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetCropFit ( bool  flag)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetExcludeAxilla ( bool  flag)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetExtInitialPect ( bool  flag)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetFatSatImage ( typename InternalImageType::Pointer  image)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetFinalSegmThreshold ( float  threshold)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetLeftBreast ( bool  flag)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetMarchingK1 ( float  k1)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetMarchingK2 ( float  k2)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetMarchingTime ( float  t)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputBackground ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputBIFS ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputBreastFittedSurfMask ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputCDF ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputChestPoints ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputClosedStructural ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputFastMarchingImage ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputFit ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputGradientMagImage ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputHistogram ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputImageMax ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputImageMaxClosed ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputPecSurfaceMask ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputPectoralMask ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputPectoralSurf ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputSkinElevationMap ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputSkinSurfaceNoBreasts ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputSmoothedFatSat ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputSmoothedStructural ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputSpeedImage ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetOutputVTKSurface ( std::string  fn)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetPectoralControlPointSpacing ( float  d)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetRegionGrowX ( int  coord)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetRegionGrowY ( int  coord)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetRegionGrowZ ( int  coord)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetRightBreast ( bool  flag)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetSigmaBIF ( float  sig)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetSigmaInMM ( float  sigma)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetSmooth ( bool  flag)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetStructuralImage ( typename InternalImageType::Pointer  image)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SetVerbose ( bool  flag)
inline
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SmoothMask ( void  )
protected

Smooth the mask and threshold to round corners etc.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SmoothMaxImageToIncreaseSeparationOfTheBackground ( void  )
protected

Smooth the image to increase separation of the background.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::SmoothTheInputImages ( void  )
protected

Smooth the structural and FatSat images.

template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::WriteBinaryImageToUCharFile ( std::string fileOutput,
const char *  description,
typename InternalImageType::Pointer  image,
enumBreastSideType  breastSide 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::WriteBinaryImageToUCharFile ( std::string fileOutput,
const char *  description,
typename InternalImageType::Pointer  image,
bool  flgLeft,
bool  flgRight 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::WriteBinaryImageToUCharFileOrVTKSurfaceFile ( std::string fileOutput,
const char *  description,
typename InternalImageType::Pointer  image,
bool  flgLeft,
bool  flgRight 
)
protected

Based on the file extension it will be decided wheter a vtk surface is written or an image is saved.

template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::WriteHistogramToFile ( std::string  fileOutput,
vnl_vector< double > &  xHistIntensity,
vnl_vector< double > &  yHistFrequency,
unsigned int  nBins 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::WriteImageToFile ( std::string fileOutput,
const char *  description,
typename InternalImageType::Pointer  image,
enumBreastSideType  breastSide 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::WriteImageToFile ( std::string fileOutput,
const char *  description,
typename InternalImageType::Pointer  image,
bool  flgLeft = false,
bool  flgRight = false 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::WriteImageToVTKSurfaceFile ( typename InternalImageType::Pointer  image,
std::string fileOutput,
enumBreastSideType  breastSide,
bool  flgVerbose,
float  finalSegmThreshold 
)
protected
template<const unsigned int ImageDimension, class InputPixelType >
void itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::WriteSegmentationToAFile ( std::string  fileOutput)
inline

Write the segmented image to a file.

Member Data Documentation

template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::bgndThresholdProb
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::coilCropDistance
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::cropDistPosteriorToMidSternum
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputBackground
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputBIFs
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputChestPoints
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputClosedStructural
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputCombinedHistogram
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputFastMarchingImage
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputFittedBreastMask
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputFreqLessBgndCDF
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputGradientMagImage
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputMaxClosedImage
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputMaxImage
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputPectoral
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputPectoralSurfaceMask
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputPectoralSurfaceVoxels
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputRayleigh
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputSkinElevationMap
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputSkinSurfaceNoBreasts
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputSmoothedFatSat
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputSmoothedStructural
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputSpeedImage
protected
template<const unsigned int ImageDimension, class InputPixelType >
std::string itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fileOutputVTKSurface
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::finalSegmThreshold
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgCropWithFittedSurface
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgExcludeAxilla
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgExtInitialPect
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgLeft
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgRegGrowXcoord
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgRegGrowYcoord
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgRegGrowZcoord
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgRight
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgSmooth
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgVerbose
protected
template<const unsigned int ImageDimension, class InputPixelType >
bool itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::flgXML
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fMarchingK1
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fMarchingK2
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::fMarchingTime
protected
template<const unsigned int ImageDimension, class InputPixelType >
unsigned int itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::i
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxAreolarLeft[4]
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxAreolarRight[4]
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxLeftBreastMidPoint
protected

Landmarks used by the segmentation.

template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxLeftPosterior
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxMidSternum
protected

Breast Landmarks.

template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxNippleLeft
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxNippleRight
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxRightBreastMidPoint
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::IndexType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::idxRightPosterior
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imBIFs
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imChestSurfaceVoxels
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imFatSat
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imMaxClosed
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imMaximum
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imPectoralSurfaceVoxels
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imPectoralVoxels
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imSegmented
protected
template<const unsigned int ImageDimension, class InputPixelType >
AxialImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imSkinElevationMap
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imSpeedFuncInputImage
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imStructural
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::Pointer itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::imTmp
protected
template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::RegionType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::m_LeftLateralRegion
protected

The left side of the image.

template<const unsigned int ImageDimension, class InputPixelType >
InternalImageType::RegionType itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::m_RightLateralRegion
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::maxIntensity
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::minIntensity
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::pecControlPointSpacing
protected
template<const unsigned int ImageDimension, class InputPixelType >
int itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::regGrowXcoord
protected
template<const unsigned int ImageDimension, class InputPixelType >
int itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::regGrowYcoord
protected
template<const unsigned int ImageDimension, class InputPixelType >
int itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::regGrowZcoord
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::sigmaBIF
protected
template<const unsigned int ImageDimension, class InputPixelType >
float itk::BreastMaskSegmentationFromMRI< ImageDimension, InputPixelType >::sigmaInMM
protected

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