diff --git a/Core/Code/DataManagement/mitkOldTypeConversions.h b/Core/Code/DataManagement/mitkOldTypeConversions.h new file mode 100644 index 0000000000..bdfe72b685 --- /dev/null +++ b/Core/Code/DataManagement/mitkOldTypeConversions.h @@ -0,0 +1,242 @@ +/*=================================================================== + +The Medical Imaging Interaction Toolkit (MITK) + +Copyright (c) German Cancer Research Center, +Division of Medical and Biological Informatics. +All rights reserved. + +This software is distributed WITHOUT ANY WARRANTY; without +even the implied warranty of MERCHANTABILITY or FITNESS FOR +A PARTICULAR PURPOSE. + +See LICENSE.txt or http://www.mitk.org for details. + +===================================================================*/ + + +#ifndef MITKOLDTYPECONVERSIONS_H_ +#define MITKOLDTYPECONVERSIONS_H_ + +#include + +#include "mitkTypeBasics.h" +#include "mitkTypedefs.h" +#include "mitkVector.h" + + +template class VectorTraits { +public: + typedef T ValueType; +}; + +template <> class VectorTraits { +public: + typedef mitk::ScalarType ValueType; +}; + +template<> class VectorTraits { +public: + typedef float ValueType; +}; + +template<> class VectorTraits< itk::Index<5> > { +public: + typedef itk::Index<5>::IndexValueType ValueType; +}; + +template<> class VectorTraits< itk::Index<3> > { +public: + typedef itk::Index<3>::IndexValueType ValueType; +}; + +template<> class VectorTraits< long int [3]> { +public: + typedef long int ValueType; +}; +template<> class VectorTraits< float [3]> { +public: + typedef float ValueType; +}; +template<> class VectorTraits< double [3]> { +public: + typedef double ValueType; +}; + +template<> class VectorTraits< vnl_vector_fixed > { +public: + typedef mitk::ScalarType ValueType; +}; + +template<> class VectorTraits< long unsigned int[3]> { +public: + typedef long unsigned int ValueType; +}; + +template<> class VectorTraits< unsigned int *> { +public: + typedef unsigned int ValueType; +}; + +template<> class VectorTraits< double[4] > { +public: + typedef double ValueType; +}; + +template<> class VectorTraits< itk::Vector > { +public: + typedef float ValueType; +}; + +template<> class VectorTraits< itk::Vector > { +public: + typedef double ValueType; +}; + +template<> class VectorTraits< itk::Vector > { +public: + typedef int ValueType; +}; +/* +template<> class VectorTraits< mitk::Vector > { +public: + typedef double ValueType; +};*/ + +template<> class VectorTraits< mitk::Point > { +public: + typedef float ValueType; +}; + +template<> class VectorTraits< mitk::Point > { +public: + typedef float ValueType; +}; + +template<> class VectorTraits< itk::Point > { +public: + typedef float ValueType; +}; + +template<> class VectorTraits< itk::Point > { +public: + typedef float ValueType; +}; + +template<> class VectorTraits< mitk::Point > { +public: + typedef double ValueType; +}; + +template<> class VectorTraits< mitk::Point > { +public: + typedef double ValueType; +}; + +template<> class VectorTraits< itk::Point > { +public: + typedef double ValueType; +}; + +template<> class VectorTraits< itk::Point > { +public: + typedef double ValueType; +}; + +template<> class VectorTraits< mitk::Point > { +public: + typedef int ValueType; +}; + +namespace mitk +{ + + template + inline void FillVector3D(Tout& out, mitk::ScalarType x, mitk::ScalarType y, mitk::ScalarType z) + { + out[0] = (typename VectorTraits::ValueType)x; + out[1] = (typename VectorTraits::ValueType)y; + out[2] = (typename VectorTraits::ValueType)z; + } + template + inline void FillVector4D(Tout& out, mitk::ScalarType x, mitk::ScalarType y, mitk::ScalarType z, mitk::ScalarType t) + { + out[0] = (typename VectorTraits::ValueType)x; + out[1] = (typename VectorTraits::ValueType)y; + out[2] = (typename VectorTraits::ValueType)z; + out[3] = (typename VectorTraits::ValueType)t; + } + + template + inline void itk2vtk(const Tin& in, Tout& out) + { + out[0]=(typename VectorTraits::ValueType)(in[0]); + out[1]=(typename VectorTraits::ValueType)(in[1]); + out[2]=(typename VectorTraits::ValueType)(in[2]); + } + + template + inline void vtk2itk(const Tin& in, Tout& out) + { + out[0]=(typename VectorTraits::ValueType)(in[0]); + out[1]=(typename VectorTraits::ValueType)(in[1]); + out[2]=(typename VectorTraits::ValueType)(in[2]); + } + + template + inline void vnl2vtk(const vnl_vector& in, Tout *out) + { + unsigned int i; + for(i=0; i + inline void vtk2vnl(const Tin *in, vnl_vector& out) + { + unsigned int i; + for(i=0; i + inline void vtk2vnlref(const Tin *in, vnl_vector_ref& out) + { + unsigned int i; + for(i=0; i + inline void vnl2vtk(const vnl_vector_fixed& in, Tout *out) + { + unsigned int i; + for(i=0; i + inline void vtk2vnl(const Tin *in, vnl_vector_fixed& out) + { + unsigned int i; + for(i=0; i + inline void TransferMatrix(const itk::Matrix& in, itk::Matrix& out) + { + for (unsigned int i = 0; i < in.RowDimensions; ++i) + for (unsigned int j = 0; j < in.ColumnDimensions; ++j) + out[i][j] = in[i][j]; + } + + +} // namespace mitk + + + + + +#endif /* MITKOLDTYPECONVERSIONS_H_ */ diff --git a/Core/Code/DataManagement/mitkPoint.h b/Core/Code/DataManagement/mitkPoint.h index 44766d5b25..0d4407f49a 100644 --- a/Core/Code/DataManagement/mitkPoint.h +++ b/Core/Code/DataManagement/mitkPoint.h @@ -1,78 +1,78 @@ /*=================================================================== The Medical Imaging Interaction Toolkit (MITK) Copyright (c) German Cancer Research Center, Division of Medical and Biological Informatics. All rights reserved. This software is distributed WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See LICENSE.txt or http://www.mitk.org for details. ===================================================================*/ #ifndef MITKPOINT_H #define MITKPOINT_H // this is needed for memcopy in ITK // can be removed when fixed in ITK #include #include #include #include #include #include #include #include #include #include -#include "mitkDataTypeBasics.h" +#include "mitkTypeBasics.h" namespace mitk { template class Point : public itk::Point { public: /** Default constructor has nothing to do. */ Point() {} /** Pass-through constructors for the Array base class. */ Point(const mitk::Point& r) : itk::Point(r) {} Point(const TCoordRep r[NPointDimension]):itk::Point(r) {} Point(const TCoordRep & v):itk::Point(v) {} Point(const itk::Point r) : itk::Point(r) {} /** * Warning: Array must have same dimension as Point */ void CopyToArray(ScalarType* const array_p) const { for (int i = 0; i < this->GetPointDimension(); i++) { array_p[i] = this->GetElement(i); } } }; typedef Point Point2D; typedef Point Point3D; typedef Point Point4D; typedef Point Point2I; typedef Point Point3I; typedef Point Point4I; } // namespace mitk #endif /* MITKPOINT_H */ diff --git a/Core/Code/DataManagement/mitkDataTypeBasics.cpp b/Core/Code/DataManagement/mitkTypeBasics.cpp similarity index 95% rename from Core/Code/DataManagement/mitkDataTypeBasics.cpp rename to Core/Code/DataManagement/mitkTypeBasics.cpp index df164a1946..3fd528f343 100644 --- a/Core/Code/DataManagement/mitkDataTypeBasics.cpp +++ b/Core/Code/DataManagement/mitkTypeBasics.cpp @@ -1,23 +1,23 @@ /*=================================================================== The Medical Imaging Interaction Toolkit (MITK) Copyright (c) German Cancer Research Center, Division of Medical and Biological Informatics. All rights reserved. This software is distributed WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See LICENSE.txt or http://www.mitk.org for details. ===================================================================*/ -#include "mitkDataTypeBasics.h" +#include "mitkTypeBasics.h" #include "vnl/vnl_math.h" #include const mitk::ScalarType mitk::eps = vnl_math::eps*100; const mitk::ScalarType mitk::sqrteps = vnl_math::sqrteps; const mitk::ScalarType mitk::large = std::numeric_limits::max(); diff --git a/Core/Code/DataManagement/mitkDataTypeBasics.h b/Core/Code/DataManagement/mitkTypeBasics.h similarity index 100% rename from Core/Code/DataManagement/mitkDataTypeBasics.h rename to Core/Code/DataManagement/mitkTypeBasics.h diff --git a/Core/Code/DataManagement/mitkTypedefs.h b/Core/Code/DataManagement/mitkTypedefs.h new file mode 100644 index 0000000000..362d967f23 --- /dev/null +++ b/Core/Code/DataManagement/mitkTypedefs.h @@ -0,0 +1,54 @@ +/*=================================================================== + +The Medical Imaging Interaction Toolkit (MITK) + +Copyright (c) German Cancer Research Center, +Division of Medical and Biological Informatics. +All rights reserved. + +This software is distributed WITHOUT ANY WARRANTY; without +even the implied warranty of MERCHANTABILITY or FITNESS FOR +A PARTICULAR PURPOSE. + +See LICENSE.txt or http://www.mitk.org for details. + +===================================================================*/ + +#ifndef MITKTYPEDEFS_H_ +#define MITKTYPEDEFS_H_ + + +#include +#include +#include +#include +#include +#include + +#include "mitkTypeBasics.h" + +//template class Vector; + +namespace mitk { + +typedef itk::Matrix Matrix3D; +typedef itk::Matrix Matrix4D; +typedef vnl_matrix_fixed VnlMatrix3D; +typedef itk::Transform Transform3D; +typedef vnl_vector VnlVector; +typedef vnl_vector_ref VnlVectorRef; + + +typedef itk::Index<3> Index3D; +typedef itk::ContinuousIndex ContinuousIndex3D; +typedef vnl_quaternion Quaternion; + +typedef itk::NumericTraits ScalarTypeNumericTraits; + + +typedef itk::Vector Vector2D; +typedef itk::Vector Vector3D; + +} + +#endif /* MITKTYPEDEFS_H_ */ diff --git a/Core/Code/DataManagement/mitkTypes.h b/Core/Code/DataManagement/mitkTypes.h index 8ef89b1a25..d9094ac2a5 100644 --- a/Core/Code/DataManagement/mitkTypes.h +++ b/Core/Code/DataManagement/mitkTypes.h @@ -1,485 +1,273 @@ /*=================================================================== The Medical Imaging Interaction Toolkit (MITK) Copyright (c) German Cancer Research Center, Division of Medical and Biological Informatics. All rights reserved. This software is distributed WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See LICENSE.txt or http://www.mitk.org for details. ===================================================================*/ #ifndef MITKVECTOR_H_HEADER_INCLUDED_C1EBD0AD #define MITKVECTOR_H_HEADER_INCLUDED_C1EBD0AD // this is needed for memcopy in ITK // can be removed when fixed in ITK #include #include #include #include #include #include #include #include #include #include -#include "mitkPoint.h" // TODO SW: should not be included here, maybe generate one "general datatype include" like mitkPrimitives.h -#include "mitkDataTypeBasics.h" - -#ifndef DOXYGEN_SKIP - -namespace mitk { - -typedef itk::Matrix Matrix3D; -typedef itk::Matrix Matrix4D; -typedef vnl_matrix_fixed VnlMatrix3D; -typedef itk::Transform Transform3D; -typedef vnl_vector VnlVector; -typedef vnl_vector_ref VnlVectorRef; +#include "mitkTypeBasics.h" +#include "mitkTypedefs.h" +#include "mitkPoint.h" // TODO SW: should not be included here, maybe generate one "general datatype include" like mitkPrimitives.h +#include "mitkVector.h" +#include "mitkOldTypeConversions.h" +#ifndef DOXYGEN_SKIP +namespace mitk { -typedef itk::Vector Vector2D; -typedef itk::Vector Vector3D; -typedef itk::Index<3> Index3D; -typedef itk::ContinuousIndex ContinuousIndex3D; -typedef vnl_quaternion Quaternion; //##Documentation //##@brief enumeration of the type a point can be enum PointSpecificationType { PTUNDEFINED = 0, PTSTART, PTCORNER, PTEDGE, PTEND }; typedef itk::NumericTraits ScalarTypeNumericTraits; -MITK_CORE_EXPORT extern const ScalarType eps; -MITK_CORE_EXPORT extern const ScalarType sqrteps; -MITK_CORE_EXPORT extern const double large; - -template class VectorTraits { - public: - typedef T ValueType; -}; - -template <> class VectorTraits { - public: - typedef ScalarType ValueType; -}; - -template<> class VectorTraits { - public: - typedef float ValueType; -}; - -template<> class VectorTraits< itk::Index<5> > { - public: - typedef itk::Index<5>::IndexValueType ValueType; -}; - -template<> class VectorTraits< itk::Index<3> > { - public: - typedef itk::Index<3>::IndexValueType ValueType; -}; - -template<> class VectorTraits< long int [3]> { - public: - typedef long int ValueType; -}; -template<> class VectorTraits< float [3]> { - public: - typedef float ValueType; -}; -template<> class VectorTraits< double [3]> { - public: - typedef double ValueType; -}; - -template<> class VectorTraits< vnl_vector_fixed > { - public: - typedef ScalarType ValueType; -}; - -template<> class VectorTraits< long unsigned int[3]> { - public: - typedef long unsigned int ValueType; -}; - -template<> class VectorTraits< unsigned int *> { - public: - typedef unsigned int ValueType; -}; - -template<> class VectorTraits< double[4] > { - public: - typedef double ValueType; -}; - -template<> class VectorTraits< itk::Vector > { - public: - typedef float ValueType; -}; - -template<> class VectorTraits< mitk::Point > { - public: - typedef float ValueType; -}; - -template<> class VectorTraits< mitk::Point > { - public: - typedef float ValueType; -}; - - -template<> class VectorTraits< itk::Point > { - public: - typedef float ValueType; -}; - -template<> class VectorTraits< itk::Point > { - public: - typedef float ValueType; -}; -template<> class VectorTraits< itk::Vector > { - public: - typedef double ValueType; -}; - -template<> class VectorTraits< mitk::Point > { - public: - typedef double ValueType; -}; - -template<> class VectorTraits< mitk::Point > { -public: - typedef double ValueType; -}; - -template<> class VectorTraits< itk::Point > { - public: - typedef double ValueType; -}; - -template<> class VectorTraits< itk::Point > { -public: - typedef double ValueType; -}; - - -template<> class VectorTraits< itk::Vector > { - public: - typedef int ValueType; -}; - -template<> class VectorTraits< mitk::Point > { - public: - typedef int ValueType; -}; - -template - inline void itk2vtk(const Tin& in, Tout& out) -{ - out[0]=(typename VectorTraits::ValueType)(in[0]); - out[1]=(typename VectorTraits::ValueType)(in[1]); - out[2]=(typename VectorTraits::ValueType)(in[2]); -} - -template - inline void vtk2itk(const Tin& in, Tout& out) -{ - out[0]=(typename VectorTraits::ValueType)(in[0]); - out[1]=(typename VectorTraits::ValueType)(in[1]); - out[2]=(typename VectorTraits::ValueType)(in[2]); -} -template - inline void FillVector3D(Tout& out, ScalarType x, ScalarType y, ScalarType z) -{ - out[0] = (typename VectorTraits::ValueType)x; - out[1] = (typename VectorTraits::ValueType)y; - out[2] = (typename VectorTraits::ValueType)z; -} -template - inline void FillVector4D(Tout& out, ScalarType x, ScalarType y, ScalarType z, ScalarType t) -{ - out[0] = (typename VectorTraits::ValueType)x; - out[1] = (typename VectorTraits::ValueType)y; - out[2] = (typename VectorTraits::ValueType)z; - out[3] = (typename VectorTraits::ValueType)t; -} - - -template - inline void vnl2vtk(const vnl_vector& in, Tout *out) -{ - unsigned int i; - for(i=0; i - inline void vtk2vnl(const Tin *in, vnl_vector& out) -{ - unsigned int i; - for(i=0; i - inline void vtk2vnlref(const Tin *in, vnl_vector_ref& out) -{ - unsigned int i; - for(i=0; i - inline void vnl2vtk(const vnl_vector_fixed& in, Tout *out) -{ - unsigned int i; - for(i=0; i - inline void vtk2vnl(const Tin *in, vnl_vector_fixed& out) -{ - unsigned int i; - for(i=0; i itk::Vector operator+(const itk::Vector &vector, const itk::Point &point) { itk::Vector sub; for( unsigned int i=0; i inline itk::Vector& operator+=(itk::Vector &vector, const itk::Point &point) { for( unsigned int i=0; i itk::Vector operator-(const itk::Vector &vector, const itk::Point &point) { itk::Vector sub; for( unsigned int i=0; i inline itk::Vector& operator-=(itk::Vector &vector, const itk::Point &point) { for( unsigned int i=0; i inline bool MatrixEqualRMS(const vnl_matrix_fixed& matrix1,const vnl_matrix_fixed& matrix2,mitk::ScalarType epsilon=mitk::eps) { if ( (matrix1.rows() == matrix2.rows()) && (matrix1.cols() == matrix2.cols()) ) { vnl_matrix_fixed differenceMatrix = matrix1-matrix2; if (differenceMatrix.rms() inline bool MatrixEqualRMS(const itk::Matrix& matrix1,const itk::Matrix& matrix2,mitk::ScalarType epsilon=mitk::eps) { return mitk::MatrixEqualRMS(matrix1.GetVnlMatrix(),matrix2.GetVnlMatrix(),epsilon); } /*! \brief Check for element-wise matrix equality with a user defined accuracy. \param matrix1 first vnl matrix \param matrix2 second vnl matrix \param epsilon user defined accuracy bounds */ template inline bool MatrixEqualElementWise(const vnl_matrix_fixed& matrix1,const vnl_matrix_fixed& matrix2,mitk::ScalarType epsilon=mitk::eps) { if ( (matrix1.rows() == matrix2.rows()) && (matrix1.cols() == matrix2.cols()) ) { for( unsigned int r=0; repsilon) { return false; } } } return true; } else { return false; } } /*! \brief Check for element-wise matrix equality with a user defined accuracy. \param matrix1 first itk matrix \param matrix2 second itk matrix \param epsilon user defined accuracy bounds */ template inline bool MatrixEqualElementWise(const itk::Matrix& matrix1,const itk::Matrix& matrix2,mitk::ScalarType epsilon=mitk::eps) { return mitk::MatrixEqualElementWise(matrix1.GetVnlMatrix(),matrix2.GetVnlMatrix(),epsilon); } template inline bool Equal(const itk::Vector& vector1, const itk::Vector& vector2, TCoordRep eps=mitk::eps) { typename itk::Vector::VectorType diff = vector1-vector2; for (unsigned int i=0; ieps || diff[i]<-eps) return false; return true; } template inline bool Equal(const itk::Point& vector1, const itk::Point& vector2, TCoordRep eps=mitk::eps) { typename itk::Point::VectorType diff = vector1-vector2; for (unsigned int i=0; ieps || diff[i]<-eps) return false; return true; } inline bool Equal(const mitk::VnlVector& vector1, const mitk::VnlVector& vector2, ScalarType eps=mitk::eps) { mitk::VnlVector diff = vector1-vector2; for (unsigned int i=0; ieps || diff[i]<-eps) return false; return true; } inline bool Equal(ScalarType scalar1, ScalarType scalar2, ScalarType eps=mitk::eps) { return fabs(scalar1-scalar2) < eps; } template inline bool Equal(const vnl_vector_fixed & vector1, const vnl_vector_fixed& vector2, TCoordRep eps=mitk::eps) { vnl_vector_fixed diff = vector1-vector2; bool returnValue = true; for( unsigned int i=0; ieps || diff[i]<-eps) { returnValue = false; } } return returnValue; } -template -inline void TransferMatrix(const itk::Matrix& in, itk::Matrix& out) -{ - for (unsigned int i = 0; i < in.RowDimensions; ++i) - for (unsigned int j = 0; j < in.ColumnDimensions; ++j) - out[i][j] = in[i][j]; -} } // namespace mitk #endif //DOXYGEN_SKIP /* * This part of the code has been shifted here to avoid compiler clashes * caused by including before the declaration of * the Equal() methods above. This problem occurs when using MSVC and is * probably related to a compiler bug. */ #include namespace mitk { typedef itk::AffineGeometryFrame::TransformType AffineTransform3D; } #define mitkSetConstReferenceMacro(name,type) \ virtual void Set##name (const type & _arg) \ { \ itkDebugMacro("setting " << #name " to " << _arg ); \ if (this->m_##name != _arg) \ { \ this->m_##name = _arg; \ this->Modified(); \ } \ } #define mitkSetVectorMacro(name,type) \ mitkSetConstReferenceMacro(name,type) #define mitkGetVectorMacro(name,type) \ itkGetConstReferenceMacro(name,type) #endif /* MITKVECTOR_H_HEADER_INCLUDED_C1EBD0AD */ diff --git a/Core/Code/files.cmake b/Core/Code/files.cmake index 7f0f9e1edb..cbd62c8bcb 100644 --- a/Core/Code/files.cmake +++ b/Core/Code/files.cmake @@ -1,367 +1,367 @@ set(H_FILES Algorithms/itkImportMitkImageContainer.h Algorithms/itkImportMitkImageContainer.txx Algorithms/itkLocalVariationImageFilter.h Algorithms/itkLocalVariationImageFilter.txx Algorithms/itkMITKScalarImageToHistogramGenerator.h Algorithms/itkMITKScalarImageToHistogramGenerator.txx Algorithms/itkTotalVariationDenoisingImageFilter.h Algorithms/itkTotalVariationDenoisingImageFilter.txx Algorithms/itkTotalVariationSingleIterationImageFilter.h Algorithms/itkTotalVariationSingleIterationImageFilter.txx Algorithms/mitkBilateralFilter.h Algorithms/mitkBilateralFilter.cpp Algorithms/mitkInstantiateAccessFunctions.h Algorithms/mitkPixelTypeList.h # Preprocessor macros taken from Boost Algorithms/mitkPPArithmeticDec.h Algorithms/mitkPPArgCount.h Algorithms/mitkPPCat.h Algorithms/mitkPPConfig.h Algorithms/mitkPPControlExprIIf.h Algorithms/mitkPPControlIf.h Algorithms/mitkPPControlIIf.h Algorithms/mitkPPDebugError.h Algorithms/mitkPPDetailAutoRec.h Algorithms/mitkPPDetailDMCAutoRec.h Algorithms/mitkPPExpand.h Algorithms/mitkPPFacilitiesEmpty.h Algorithms/mitkPPFacilitiesExpand.h Algorithms/mitkPPLogicalBool.h Algorithms/mitkPPRepetitionDetailDMCFor.h Algorithms/mitkPPRepetitionDetailEDGFor.h Algorithms/mitkPPRepetitionDetailFor.h Algorithms/mitkPPRepetitionDetailMSVCFor.h Algorithms/mitkPPRepetitionFor.h Algorithms/mitkPPSeqElem.h Algorithms/mitkPPSeqForEach.h Algorithms/mitkPPSeqForEachProduct.h Algorithms/mitkPPSeq.h Algorithms/mitkPPSeqEnum.h Algorithms/mitkPPSeqSize.h Algorithms/mitkPPSeqToTuple.h Algorithms/mitkPPStringize.h Algorithms/mitkPPTupleEat.h Algorithms/mitkPPTupleElem.h Algorithms/mitkPPTupleRem.h Algorithms/mitkClippedSurfaceBoundsCalculator.h Algorithms/mitkExtractSliceFilter.h Algorithms/mitkConvert2Dto3DImageFilter.h Algorithms/mitkPlaneClipping.h Common/mitkExceptionMacro.h Common/mitkServiceBaseObject.h Common/mitkTestingMacros.h DataManagement/mitkImageAccessByItk.h DataManagement/mitkImageCast.h DataManagement/mitkImagePixelAccessor.h DataManagement/mitkImagePixelReadAccessor.h DataManagement/mitkImagePixelWriteAccessor.h DataManagement/mitkImageReadAccessor.h DataManagement/mitkImageWriteAccessor.h DataManagement/mitkITKImageImport.h DataManagement/mitkITKImageImport.txx DataManagement/mitkImageToItk.h DataManagement/mitkImageToItk.txx Interactions/mitkEventMapperAddOn.h Interfaces/mitkIDataNodeReader.h Rendering/mitkLocalStorageHandler.h IO/mitkPixelTypeTraits.h ) set(CPP_FILES Algorithms/mitkBaseDataSource.cpp Algorithms/mitkDataNodeSource.cpp Algorithms/mitkGeometry2DDataToSurfaceFilter.cpp Algorithms/mitkHistogramGenerator.cpp Algorithms/mitkImageChannelSelector.cpp Algorithms/mitkImageSliceSelector.cpp Algorithms/mitkImageSource.cpp Algorithms/mitkImageTimeSelector.cpp Algorithms/mitkImageToImageFilter.cpp Algorithms/mitkImageToSurfaceFilter.cpp Algorithms/mitkPointSetSource.cpp Algorithms/mitkPointSetToPointSetFilter.cpp Algorithms/mitkRGBToRGBACastImageFilter.cpp Algorithms/mitkSubImageSelector.cpp Algorithms/mitkSurfaceSource.cpp Algorithms/mitkSurfaceToImageFilter.cpp Algorithms/mitkSurfaceToSurfaceFilter.cpp Algorithms/mitkUIDGenerator.cpp Algorithms/mitkVolumeCalculator.cpp Algorithms/mitkClippedSurfaceBoundsCalculator.cpp Algorithms/mitkExtractSliceFilter.cpp Algorithms/mitkConvert2Dto3DImageFilter.cpp Controllers/mitkBaseController.cpp Controllers/mitkCallbackFromGUIThread.cpp Controllers/mitkCameraController.cpp Controllers/mitkCameraRotationController.cpp Controllers/mitkCoreActivator.cpp Controllers/mitkFocusManager.cpp Controllers/mitkLimitedLinearUndo.cpp Controllers/mitkOperationEvent.cpp Controllers/mitkPlanePositionManager.cpp Controllers/mitkProgressBar.cpp Controllers/mitkRenderingManager.cpp Controllers/mitkSliceNavigationController.cpp Controllers/mitkSlicesCoordinator.cpp Controllers/mitkSlicesRotator.cpp Controllers/mitkSlicesSwiveller.cpp Controllers/mitkStatusBar.cpp Controllers/mitkStepper.cpp Controllers/mitkTestManager.cpp Controllers/mitkUndoController.cpp Controllers/mitkVerboseLimitedLinearUndo.cpp Controllers/mitkVtkInteractorCameraController.cpp Controllers/mitkVtkLayerController.cpp DataManagement/mitkAbstractTransformGeometry.cpp DataManagement/mitkAnnotationProperty.cpp DataManagement/mitkApplicationCursor.cpp DataManagement/mitkBaseData.cpp DataManagement/mitkBaseProperty.cpp DataManagement/mitkClippingProperty.cpp DataManagement/mitkChannelDescriptor.cpp DataManagement/mitkColorProperty.cpp DataManagement/mitkDataStorage.cpp #DataManagement/mitkDataTree.cpp DataManagement/mitkDataNode.cpp DataManagement/mitkDataNodeFactory.cpp #DataManagement/mitkDataTreeStorage.cpp DataManagement/mitkDisplayGeometry.cpp DataManagement/mitkEnumerationProperty.cpp DataManagement/mitkGeometry2D.cpp DataManagement/mitkGeometry2DData.cpp DataManagement/mitkGeometry3D.cpp DataManagement/mitkGeometryData.cpp DataManagement/mitkGroupTagProperty.cpp DataManagement/mitkImage.cpp DataManagement/mitkImageAccessorBase.cpp DataManagement/mitkImageCaster.cpp DataManagement/mitkImageCastPart1.cpp DataManagement/mitkImageCastPart2.cpp DataManagement/mitkImageCastPart3.cpp DataManagement/mitkImageCastPart4.cpp DataManagement/mitkImageDataItem.cpp DataManagement/mitkImageDescriptor.cpp DataManagement/mitkImageVtkAccessor.cpp DataManagement/mitkImageStatisticsHolder.cpp DataManagement/mitkLandmarkBasedCurvedGeometry.cpp DataManagement/mitkLandmarkProjectorBasedCurvedGeometry.cpp DataManagement/mitkLandmarkProjector.cpp DataManagement/mitkLevelWindow.cpp DataManagement/mitkLevelWindowManager.cpp DataManagement/mitkLevelWindowPreset.cpp DataManagement/mitkLevelWindowProperty.cpp DataManagement/mitkLookupTable.cpp DataManagement/mitkLookupTables.cpp # specializations of GenericLookupTable DataManagement/mitkMemoryUtilities.cpp DataManagement/mitkModalityProperty.cpp DataManagement/mitkModeOperation.cpp DataManagement/mitkNodePredicateAnd.cpp DataManagement/mitkNodePredicateBase.cpp DataManagement/mitkNodePredicateCompositeBase.cpp DataManagement/mitkNodePredicateData.cpp DataManagement/mitkNodePredicateDataType.cpp DataManagement/mitkNodePredicateDimension.cpp DataManagement/mitkNodePredicateFirstLevel.cpp DataManagement/mitkNodePredicateNot.cpp DataManagement/mitkNodePredicateOr.cpp DataManagement/mitkNodePredicateProperty.cpp DataManagement/mitkNodePredicateSource.cpp DataManagement/mitkPlaneOrientationProperty.cpp DataManagement/mitkPlaneGeometry.cpp DataManagement/mitkPlaneOperation.cpp DataManagement/mitkPointOperation.cpp DataManagement/mitkPointSet.cpp DataManagement/mitkProperties.cpp DataManagement/mitkPropertyList.cpp DataManagement/mitkRestorePlanePositionOperation.cpp DataManagement/mitkRotationOperation.cpp DataManagement/mitkSlicedData.cpp DataManagement/mitkSlicedGeometry3D.cpp DataManagement/mitkSmartPointerProperty.cpp DataManagement/mitkStandaloneDataStorage.cpp DataManagement/mitkStateTransitionOperation.cpp DataManagement/mitkStringProperty.cpp DataManagement/mitkSurface.cpp DataManagement/mitkSurfaceOperation.cpp DataManagement/mitkThinPlateSplineCurvedGeometry.cpp DataManagement/mitkTimeSlicedGeometry.cpp DataManagement/mitkTransferFunction.cpp DataManagement/mitkTransferFunctionProperty.cpp DataManagement/mitkTransferFunctionInitializer.cpp DataManagement/mitkVector.cpp - DataManagement/mitkDataTypeBasics.cpp + DataManagement/mitkTypeBasics.cpp DataManagement/mitkVtkInterpolationProperty.cpp DataManagement/mitkVtkRepresentationProperty.cpp DataManagement/mitkVtkResliceInterpolationProperty.cpp DataManagement/mitkVtkScalarModeProperty.cpp DataManagement/mitkVtkVolumeRenderingProperty.cpp DataManagement/mitkWeakPointerProperty.cpp DataManagement/mitkRenderingModeProperty.cpp DataManagement/mitkShaderProperty.cpp DataManagement/mitkResliceMethodProperty.cpp DataManagement/mitkMaterial.cpp DataManagement/mitkPointSetShapeProperty.cpp Interactions/mitkAction.cpp Interactions/mitkAffineInteractor.cpp Interactions/mitkBindDispatcherInteractor.cpp Interactions/mitkCoordinateSupplier.cpp Interactions/mitkDataInteractor.cpp Interactions/mitkDispatcher.cpp Interactions/mitkDisplayCoordinateOperation.cpp Interactions/mitkDisplayInteractor.cpp Interactions/mitkDisplayPositionEvent.cpp # Interactions/mitkDisplayVectorInteractorLevelWindow.cpp # legacy, prob even now unneeded # Interactions/mitkDisplayVectorInteractorScroll.cpp Interactions/mitkEvent.cpp Interactions/mitkEventConfig.cpp Interactions/mitkEventDescription.cpp Interactions/mitkEventFactory.cpp Interactions/mitkInteractionEventHandler.cpp Interactions/mitkEventMapper.cpp Interactions/mitkEventStateMachine.cpp Interactions/mitkGlobalInteraction.cpp Interactions/mitkInteractor.cpp Interactions/mitkInternalEvent.cpp Interactions/mitkInteractionEvent.cpp Interactions/mitkInteractionEventConst.cpp Interactions/mitkInteractionPositionEvent.cpp Interactions/mitkInteractionKeyEvent.cpp Interactions/mitkMousePressEvent.cpp Interactions/mitkMouseMoveEvent.cpp Interactions/mitkMouseReleaseEvent.cpp Interactions/mitkMouseWheelEvent.cpp Interactions/mitkMouseDoubleClickEvent.cpp Interactions/mitkMouseModeSwitcher.cpp Interactions/mitkMouseMovePointSetInteractor.cpp Interactions/mitkMoveBaseDataInteractor.cpp Interactions/mitkNodeDepententPointSetInteractor.cpp Interactions/mitkPointSetDataInteractor.cpp Interactions/mitkPointSetInteractor.cpp Interactions/mitkPositionEvent.cpp Interactions/mitkPositionTracker.cpp Interactions/mitkStateMachineAction.cpp Interactions/mitkStateMachineCondition.cpp Interactions/mitkStateMachineState.cpp Interactions/mitkStateMachineTransition.cpp Interactions/mitkState.cpp Interactions/mitkStateMachineContainer.cpp Interactions/mitkStateEvent.cpp Interactions/mitkStateMachine.cpp Interactions/mitkStateMachineFactory.cpp Interactions/mitkTransition.cpp Interactions/mitkWheelEvent.cpp Interactions/mitkKeyEvent.cpp Interactions/mitkVtkEventAdapter.cpp Interactions/mitkVtkInteractorStyle.cxx Interactions/mitkCrosshairPositionEvent.cpp Interfaces/mitkInteractionEventObserver.cpp Interfaces/mitkIShaderRepository.cpp IO/mitkBaseDataIOFactory.cpp IO/mitkCoreDataNodeReader.cpp IO/mitkDicomSeriesReader.cpp IO/mitkFileReader.cpp IO/mitkFileSeriesReader.cpp IO/mitkFileWriter.cpp #IO/mitkIpPicGet.c IO/mitkImageGenerator.cpp IO/mitkImageWriter.cpp IO/mitkImageWriterFactory.cpp IO/mitkItkImageFileIOFactory.cpp IO/mitkItkImageFileReader.cpp IO/mitkItkLoggingAdapter.cpp IO/mitkItkPictureWrite.cpp IO/mitkIOUtil.cpp IO/mitkLookupTableProperty.cpp IO/mitkOperation.cpp #IO/mitkPicFileIOFactory.cpp #IO/mitkPicFileReader.cpp #IO/mitkPicFileWriter.cpp #IO/mitkPicHelper.cpp #IO/mitkPicVolumeTimeSeriesIOFactory.cpp #IO/mitkPicVolumeTimeSeriesReader.cpp IO/mitkPixelType.cpp IO/mitkPointSetIOFactory.cpp IO/mitkPointSetReader.cpp IO/mitkPointSetWriter.cpp IO/mitkPointSetWriterFactory.cpp IO/mitkRawImageFileReader.cpp IO/mitkStandardFileLocations.cpp IO/mitkSTLFileIOFactory.cpp IO/mitkSTLFileReader.cpp IO/mitkSurfaceVtkWriter.cpp IO/mitkSurfaceVtkWriterFactory.cpp IO/mitkVtkLoggingAdapter.cpp IO/mitkVtiFileIOFactory.cpp IO/mitkVtiFileReader.cpp IO/mitkVtkImageIOFactory.cpp IO/mitkVtkImageReader.cpp IO/mitkVtkSurfaceIOFactory.cpp IO/mitkVtkSurfaceReader.cpp IO/vtkPointSetXMLParser.cpp IO/mitkLog.cpp Rendering/mitkBaseRenderer.cpp Rendering/mitkVtkMapper.cpp Rendering/mitkRenderWindowFrame.cpp Rendering/mitkGeometry2DDataMapper2D.cpp Rendering/mitkGeometry2DDataVtkMapper3D.cpp Rendering/mitkGLMapper.cpp Rendering/mitkGradientBackground.cpp Rendering/mitkManufacturerLogo.cpp Rendering/mitkMapper.cpp Rendering/mitkPointSetGLMapper2D.cpp Rendering/mitkPointSetVtkMapper2D.cpp Rendering/mitkPointSetVtkMapper3D.cpp Rendering/mitkPolyDataGLMapper2D.cpp Rendering/mitkSurfaceGLMapper2D.cpp Rendering/mitkSurfaceVtkMapper3D.cpp Rendering/mitkVolumeDataVtkMapper3D.cpp Rendering/mitkVtkPropRenderer.cpp Rendering/mitkVtkWidgetRendering.cpp Rendering/vtkMitkRectangleProp.cpp Rendering/vtkMitkRenderProp.cpp Rendering/mitkVtkEventProvider.cpp Rendering/mitkRenderWindow.cpp Rendering/mitkRenderWindowBase.cpp Rendering/mitkShaderRepository.cpp Rendering/mitkImageVtkMapper2D.cpp Rendering/vtkMitkThickSlicesFilter.cpp Rendering/vtkMitkLevelWindowFilter.cpp Rendering/vtkNeverTranslucentTexture.cpp Rendering/mitkRenderingTestHelper.cpp Common/mitkException.cpp Common/mitkCommon.h Common/mitkCoreObjectFactoryBase.cpp Common/mitkCoreObjectFactory.cpp Common/mitkCoreServices.cpp ) list(APPEND CPP_FILES ${CppMicroServices_SOURCES}) set(RESOURCE_FILES Interactions/globalConfig.xml Interactions/DisplayInteraction.xml Interactions/DisplayConfig.xml Interactions/DisplayConfigPACS.xml Interactions/DisplayConfigPACSPan.xml Interactions/DisplayConfigPACSScroll.xml Interactions/DisplayConfigPACSZoom.xml Interactions/DisplayConfigPACSLevelWindow.xml Interactions/DisplayConfigMITK.xml Interactions/PointSet.xml Interactions/Legacy/StateMachine.xml Interactions/Legacy/DisplayConfigMITKTools.xml Interactions/PointSetConfig.xml Shaders/mitkShaderLighting.xml mitkLevelWindowPresets.xml )