CBrentFunction | |
CCORE_Array | This class describes an array |
CCORE_Array2D | This class describes an array of arrays ordered by rows The array like this 0 1 2 3 4 |
CCORE_Array3D | This class describes an array of arrays stored as follow: |
CCORE_ArrayList | |
CCORE_ClassFactory | This class describes a class factory to generate classes for User Interface Software |
CCORE_Color | This class describes color |
CCORE_CommandLine | This class is the class to manage CORE from command line |
CCORE_Complex | This class describes a complex |
CCORE_Exception | This class describes the exceptions raised for CORE package |
CCORE_File | This class describes a file |
CCORE_Integer | This class describes an integer |
CCORE_IO | This class describes the IO class |
CCORE_IORun | This class is a Run class for Common/IO package |
CCORE_IOTest | This class is a test class for common/io package |
CCORE_List | This class describes a list interface |
CCORE_Map | This class describes a map |
CCORE_MorseArray | This class describes a general morse array of size N. A morse array is composed by |
CCORE_MorseArrayConstIterator | This class describes a more array iterator |
CCORE_MorseArrayIterator | This class describes a more array iterator |
►CCORE_Object | Abstract base class for most classes |
CDelete | Class Free introduced for deleting a smart pointer |
CCORE_Out | This class describes the output by default write on standart output |
CCORE_ReadingFile | This class describes a file open for reading |
CCORE_Real | This class describes a real Attributes: |
CCORE_Run | This class is a Run class for Common package |
CCORE_SharedPointersArray | Class CORE_SharedPointersArray is a list of shared pointers |
CCORE_SharedPointersKVMap | This class describes a map: shared pointer of Key -> shared pointer of Value |
CCORE_SharedPointersList | Class CORE_SharedPointersList is a list of shared pointers |
CCORE_SharedPointersListVMap | This class describes a map: primitive type of Key -> shared pointer of list of Value |
CCORE_SharedPointersMatrix | Class CORE_SharedPointersMatrix is a matrix of shared pointers Matrix is a vector of shared pointer of T |
CCORE_SharedPointersVMap | This class describes a map: primitive type of Key -> shared pointer of Value |
CCORE_String | This class describes a string |
CCORE_StringArrayList | This class describes an array of string viewed as a list |
CCORE_Test | This class is a test class for common package |
CCORE_Thread | This class describes a program routine analyser |
CCORE_Time | This class describes a time class |
CCORE_Vector | This class describes an array |
CCORE_VectorReader | This class describes a reader for vector value |
CCORE_WeakPointersArray | Class CORE_WeakPointersArray is an array of weak pointers |
CCORE_WeakPointersList | Class CORE_WeakPointersList is a list of weak shared pointers |
CCORE_WritingFile | This class describes a writing file |
CEMM_2PackedSymmetricTensors | This class describes a morse array of symmetric tensors of 2 order in packed form |
CEMM_2Tensors | This class describes a morse array of tensors of 2 order |
CEMM_4SymmetricTensors | This class describes a morse array of symmetric tensors of 4 order |
CEMM_4Tensors | This class describes a morse array of tensors of 4 order |
CEMM_AnisotropyDirectionsField | This class describes the field of directions of anisotropy This fields contains 2 arrays : |
CEMM_AnisotropyOperator | This class describes the mixed anistropy operators of the landau lifschitz system EMM_LandauLifschitzSystem |
CEMM_Array | This class describes a general array |
CEMM_BlockEquilibriumMatrix | This class describes the equilibrium matrix coressponding to the linear symmetric definite positive operator |
CEMM_BlockMassMatrix | This class describes the mass matrix where is the Q1 function which is 1 on the point i and 0 otherwise |
CEMM_BrentIterativeTimeStep | This class compute the new time step by optimizing a function EMM_LandauLisfchitzSystem::computeEnergyAtTime() within the optimizeTimeFunction() method as the quadratic / golden number optimization. See https://www.boost.org/doc/libs/1_71_0/libs/math/doc/html/math_toolkit/brent_minima.html |
CEMM_CanonicalMassMatrix | This class describes the mass matrix where is the P1 function with is 1 on the point i and 0 otherwise |
CEMM_CaseTest | This class is a test class for testing interesting real cases |
CEMM_ClassFactory | This class describes a class factory to generate classes for the E-MicromM Package |
CEMM_CondensedMassMatrix | This class describes the condensed mass matrix where is the P1 function with is 1 on the point i and 0 otherwise |
CEMM_CubicAnisotropyOperator | This class describes the cubic anistropy operator of the landau lifschitz system EMM_LandauLifschitzSystem |
CEMM_CubicElasticMatter | This class describes an cubic elastic matter for E-MicroM package |
CEMM_DemagnetizedOperator | This class describes the linear demagnetized operator of the Landau Lifschitz system EMM_LandauLifschitzSystem |
CEMM_DemagnetizedPeriodicalTest | This class is a test class for testing demagnetized operator in periodical domain |
CEMM_DemagnetizedTest | This class is a test class for testing primary methods for magnetostriction operator |
CEMM_DisplacementFEMOperator | This class describes the displacement operator defined on the points of the mesh |
CEMM_DisplacementFieldsTest | This class is a test class for testing displacement fields computation methods for displacement operators |
CEMM_DisplacementFVM_Interpolator | |
CEMM_DisplacementFVM_SSGROperator | This class describes the displacement operator defined on the cells of the mesh with Surface Gradient Reconstruction |
CEMM_DisplacementFVM_STEGROperator | This class describes the displacement operator defined on the cells of the mesh with Surface Gradient Reconstruction |
CEMM_DisplacementFVM_VGROperator | This class describes the displacement operator defined on the cells of the mesh with Volume Gradient Reconstruction |
CEMM_DisplacementFVM_VIGROperator | This class describes the displacement operator defined on the cells of the mesh with Volume Gradient Reconstruction based on global vertices interpolation |
CEMM_DisplacementFVM_VOGGROperator | This class describes the method to interpolate U on points, faces and cells |
CEMM_DisplacementFVM_VTEGROperator | This class describes the displacement operator defined on the cells of the mesh with Volume Gradient Reconstruction |
CEMM_DisplacementFVMOperator | This class describes the displacement operator defined on the cells of the mesh |
CEMM_DisplacementFVMTest | This class is a test class for testing primary methods for displacement FVM operator |
CEMM_DisplacementOperator | This class describes the displacement operator defined on the data of the mesh |
CEMM_DisplacementTest | This class is a test class for testing primary methods for displacement operator |
CEMM_DisplacementWaveTest | This class is a test class for testing only the wave displacement in the magnetostriction equation: |
CEMM_DistanceFunction | This class create a distance function |
CEMM_ElasticStressTest | This class is a test class for testing elastic stress commputing method of displacement operators |
CEMM_ElementaryDemagnetizedMatrix | This class create the elementary demagnetized matrix : |
CEMM_ElementaryTest | This class is a test class for testing trivial cases |
CEMM_Exception | This class describes the exceptions raised for E-MicromM package |
CEMM_ExchangeOperator | This class describes the exchange operator for computing the magnetic excitation due to exchange process for the E-MicroM system EMM_LandauLifschitzSystem |
CEMM_FieldTest | This class is a test class for testing EMM_Field classes |
CEMM_FullExchangeOperator | This class describes an implementation of the exchange operator EMM_MinimalExchangeOperator |
CEMM_GaussLegendreRelaxation | This class describes implements the main method for the relaxation processs of the Landau Lifschitz System : |
CEMM_GoldenNumberIterativeTimeStep | This class compute the new time step by optimizing a function EMM_LandauLisfchitzSystem::computePredictiveEnergyAtTime() within the optimizeTimeFunction() method as the golden number optimization |
CEMM_GradGaussLegendreRelaxation | This class describes implements the gradient of the landau Lifschitz function to use optimal time step computation and the Gauss-Legendre integral interpolation to build the new magnetization field |
CEMM_Grid3D | This class describes a grid3d mesh |
CEMM_Grid3DTest | This class is a test class for testing EMM_Grid3D classes |
CEMM_HyperElasticMatter | This class describes an hyper elastic matter for E-MicroM package |
CEMM_Hysteresis | This class generate the hystesis file (see EMMH_HisteresysFile) |
CEMM_HysteresisFile | This class manages the hysteresis file; The file format of the hysteresis file is as follow: |
CEMM_Input | This class is a Input class for StochMagnet core package |
CEMM_IO | This class is a I/O class for E-MicroM core package |
CEMM_IterativeTimeStep | This class describes the iterative optimal time |
CEMM_Kd | This class create the integration of Laplacian inverse EMM_LI in [0,1]x[0,1]x[0,1] |
CEMM_Kd_xx | This class computes the function: |
CEMM_Kd_xy | This class computes the function : |
CEMM_Kd_xz | |
CEMM_Kd_yy | This class computes the function |
CEMM_Kd_yz | |
CEMM_Kd_zz | |
CEMM_LandauLifschitzFunction | This class describes a landau lischitz function & utilitis: |
CEMM_LandauLifschitzODE | This class describes a resolution of Landau-Lifschitz system of the Core Package for E-MicroM package with an ODE integration |
CEMM_LandauLifschitzODE_RK | This class implements a general Runge Kutta formulation to integrate the ODE System |
CEMM_LandauLifschitzODE_RKd | This class implements a general Runge Kutta formulation to integrate the ODE System using a developped implementation |
CEMM_LandauLifschitzRelaxation | This class describes a resolution of landau-lifschitz system of the Core Package for E-MicroM |
CEMM_LandauLifschitzRK45 | This class implements a Runge Kutta of order 5 to integrate the ODE System |
CEMM_LandauLifschitzRK45d | This class implements a Runge Kutta of order 5 to integrate the ODE System using a developped implementation |
CEMM_LandauLifschitzSystem | This class describes a resolution of landau-lifschitz system of the Core Package for E-MicroM |
CEMM_LinearAnisotropyOperator | This class describes the linear anistropy operator of the landau lifschitz system EMM_LandauLifschitzSystem |
CEMM_MagneticExcitationLinearOperator | This class describes the MagneticExcitationLinear operator for the E-MicroM system : EMM_LandauLisfchitzSystem |
CEMM_MagneticExcitationOperator | This class is an operator of a E-MicromM package wich compute a magnetic excitation operator |
CEMM_MagneticStressTest | This class is a test class for testing magnetic stress commputing method of displacement operators |
CEMM_MagnetostrictionOperator | This class describes the magnetostriction operator of the landau lifshcitz system EMM_LandauLifschitzSystem |
CEMM_MagnetostrictionTest | This class is a test class for testing primary methods for magnetostriction operator |
CEMM_MagnetostrictiveMatter | This class describes an magnetostrive matter for E-MicroM package |
CEMM_MassMatrix | This interface class describes the mass matrix where is the Q1 function with is 1 on the point i and 0 otherwise with block size equals to 1 |
CEMM_Matter | This class describes a matter for E-MicroM package |
CEMM_MatterField | This class describes the field of matters |
CEMM_MatterTest | This class is a test class for testing EMM_Matter classes |
CEMM_MinimalExchangeOperator | This class describes an implementation of the exchange operator EMM_ExchangeOperator |
CEMM_MorseArrayTest | This class is a test class for testing EMM_MorseArray classes |
CEMM_MultiScaleCDGrid | This class describes the building of fields on multiscale centered dioptic grids initialized by the initialize() method |
CEMM_MultiScaleGrid | This class describes the building of fields on multiscale grid initialized by the initialize() method. The magnetic excitation field is computed by the method computeMultiGridExcitationField() |
CEMM_MultiScaleSDGrid | This class describes the building of fields on multiscale shift dioptic grids initialized by the initialize() method |
CEMM_NewtonRaphsonIterativeTimeStep | This class compute the new time step by optimizing a function EMM_LandauLisfchitzSystem::computeEnergyAtTime() within the optimizeTimeFunction() method as the newton raphson optimization. Builds a sequence |
CEMM_Object | This class is a base class of E-MicromM core package |
CEMM_ODEClassFactory | This class describes a class factory to generate classes for the E-MicromM Package |
CEMM_ODETest | This class is a test class for testing EMM_ODE classes |
CEMM_ODETimeStep | This class describes an ODE Time step |
CEMM_Operator | This class is an operator of a E-MicromM package which computes the field of the operator with respect of the magnetization M. It computes after discretizing the operator (see discretize() ) : |
CEMM_OperatorClassFactory | This class describes a class factory to generate classes for the E-MicromM Package |
CEMM_OperatorsTest | This class is the operators test class for E-MicroM in grid3D domain |
CEMM_OptimalIterativeTimeStep | This class compute the new time step by using the optimal time step and with a golden method if the taylor approximation is too bad for big time step |
CEMM_OptimalTimeStep | This class describes the optimal time |
CEMM_Output | This class is a Output class for E-MicroM core package |
CEMM_PlanarAnisotropyOperator | This class describes the planar anistropy operator of the landau lifschitz system EMM_LandauLifschitzSystem |
CEMM_PolynomialInterpolationTimeStep | This class describes the polynomial interpolation for computing the optimal time |
CEMM_PrimaryTest | This class is a test class for testing trivial cases |
CEMM_QuadraticNumberIterativeTimeStep | This class compute the new time step by optimizing a function EMM_LandauLisfchitzSystem::computePredictiveEnergyAtTime() within the optimizeTimeFunction() method as the quadratic number optimization |
CEMM_QuasiNewtonIterativeTimeStep | This class compute the new time step by optimizing a function EMM_LandauLisfchitzSystem::computePredictiveEnergyAtTime() within the optimizeTimeFunction() method as the quasi newton optimization |
CEMM_RealArray | This class describes a real array |
CEMM_RealField | This class describes a real field |
CEMM_RegularTimeStep | This class describes a regular time |
CEMM_RelaxationClassFactory | This class describes a class factory to generate classes for the E-MicromM Package |
CEMM_RelaxationTest | This class is a test class for testing EMM_Relaxation classes |
CEMM_Run | This class is the runner class for the generic package of the core module of mricom Package |
CEMM_SecondOrderIterativeTimeStep | This class describes the iterative wich uses the secund derivatives of E |
CEMM_SLElementaryDemagnetizedMatrix | This class describes gaussian interpolation |
CEMM_StaticMagneticTensorOperator | This class describes the static Magnetic Tensor operator of the landau lifschitz system EMM_LandauLifschitzSystem |
CEMM_StaticMagnetostrictionOperator | This class describes the static magnetostriction operator of the landau lifschitz system EMM_LandauLifschitzSystem |
CEMM_Stepper | This class describes a time descriptor |
CEMM_TaylorExpansionRelaxation | This class describes implements the main method for the relaxation processs of the Landau Lifschitz System : |
CEMM_Tensors | This class describes a morse array of tensors |
CEMM_TensorsClassFactory | This class describes a class factory to generate generic classes for the core module of the microm Package |
CEMM_TensorsRun | |
CEMM_TensorsTest | This class is a test class for E-MicromM package |
CEMM_Test | This class is a test class for E-MicromM package |
CEMM_TimeClassFactory | This class describes a class factory to generate classes for the E-MicromM Package |
CEMM_TimeTest | This class is a test class for testing trivial cases |
CEMM_UniaxialAnisotropyOperator | This class describes the uniaxial anistropy operator of the landau lifschitz system EMM_LandauLifschitzSystem |
CEMM_VelocitySolverTest | This class is a test class for solving velocity linear system |
CEMM_VTK | This class is a I/O output class for VTK / Paraviwe file |
CEMM_WaveFDMTest | This class is a test class for testing wave equation using the Finite Differences Method: |
CEMM_WaveFEMTest | This class is a test class for testing wave equation using the Finite elements Method with two implementation of the obtained mass matrix as diagonal or not |
CEMM_WaveTest | This class is a test class for testing wave equation : |
CEMM_ZeemanOperator | This class describes the Zeeman operator which is the exterior excitation magnetic field from the E-MicroM system : EMM_LandauLifschitzSystem |
CEMMG_AnisotropyOperator | This class describes the mixed anistropy operator EMM_AnisotropyOperator of the landau lifschitz system EMM_LandauLifschitzSystem basedon an EMMG_RealField |
CEMMG_ClassFactory | This class describes a class factory to generate generic classes for the core module of the microm Package |
CEMMG_CubicAnisotropyOperator | This class describes the cubic anistropy operator EMM_CubicAnisotropyOperator of the landau lifschitz system EMM_LandauLifschitzSystem based on EMMG_RealField |
CEMMG_DemagnetizedOperator | This class describes the linear demagnetized operator EMM_DemagnetizedOperator of the Landau Lifschitz system EMM_LandauLifschitzSystem based on EMMG_RealField |
CEMMG_DisplacementFEMOperator | This class describes the displacement operator based on Finite Elements Method EMM_DisplacementFEMOperator for the EMMG_MagnetostrictionOperator class |
CEMMG_DisplacementFVM_SSGROperator | This class describes the displacement operator based on Finite Differences Method EMM_DisplacementFVMOperator for the EMMG_MagnetostrictionOperator class |
CEMMG_DisplacementFVM_STEGROperator | This class describes the displacement operator based on Finite Differences Method EMM_DisplacementFVMOperator for the EMMG_MagnetostrictionOperator class |
CEMMG_DisplacementFVM_VOGGROperator | This class describes the displacement operator based on Finite Volumes Method for the EMMG_MagnetostrictionOperator class |
CEMMG_DisplacementFVM_VTEGROperator | This class describes the displacement operator based on Finite Differences Method EMM_DisplacementFVMOperator for the EMMG_MagnetostrictionOperator class |
CEMMG_FullExchangeOperator | This class describes an implementation of the exchange operator EMM_FullExchangeOperator using an EMMG_RealField class |
CEMMG_LandauLifschitzFunction | This class describes a implementation of a landau lischitz function & utility: |
CEMMG_LinearAnisotropyOperator | This class describes an implementation of the mixed of linear anistropy operators EMM_LinearAnisotropyOperator of the landau lifschitz system EMM_LandauLifschitzSystem based on the EMMG_RealField |
CEMMG_MagnetostrictionOperator | This class describes the magnetostriction operator EMM_MagnetostrictionOperator of the landau lifschitz system EMM_LandauLifschitzSystem basedon an EMMG_RealField |
CEMMG_MinimalExchangeOperator | This class describes an implementation of the exchange operator EMM_MinimalExchangeOperator using an EMMG_RealField class |
CEMMG_PlanarAnisotropyOperator | This class describes the planar anisotropy operator EMM_PlanarAnisotropyOperator using field implemented by the EMMG_RealField class |
CEMMG_RealField | This class describes a generic real field |
CEMMG_Run | |
CEMMG_SLDemagnetizedOperator | This class describes the linear demagnetized operator of the landau lifschitz system EMM_LandauLifschitzSystem |
CEMMG_SLPeriodicMultiScale | This class describes the PeriodicMultiScale for matrix-vector product of complex toeplitz matrix |
CEMMG_SLRPPeriodicMultiScale | This class describes the PeriodicRPMultiScale for matrix-vector product of complex toeplitz matrix |
CEMMG_SLSDXPeriodicMultiScale | This class describes the PeriodicSDXMultiScale for matrix-vector product of complex toeplitz matrix |
CEMMG_StaticMagneticTensorOperator | This class describes the static magnetostriction operator EMM_StaticMagneticTensorOperator of the landau lifschitz system EMM_LandauLifschitzSystem based on an EMMG_RealField |
CEMMG_StaticMagnetostrictionOperator | This class describes the static magnetostriction operator EMM_StaticMagnetostrictionOperator of the landau lifschitz system EMM_LandauLifschitzSystem based on an EMMG_RealField |
CEMMG_UniaxialAnisotropyOperator | This class describes an implementation the uniaxial anistropy operator EMM_UniaxialAnisotropyOPerator of the landau lifschitz system EMM_LandauLifschitzSystem based on EMMG_RealField |
CEMMH_ClassFactory | This class describes a class factory to generate generic classes for the core module of the microm Package |
CEMMH_Hysteresis | |
CEMMH_HysteresisFile | |
CEMMH_HysteresisTest | This class is the test the hysteresis classes from Hysteresis Package for E-MicroM |
CEMMH_Run | |
CEMMM_Run | This class is the runner class for E-MicroM Package |
CFFTW_ClassFactory | This class describes a class factory to generate classes for the math/fftw Package |
CFFTW_Complex | This class describes complex based on fftw_complex structure |
CFFTW_ComplexArray | This class describes FFT complex array based on fft_complex structure |
CFFTW_DFT | This class computes FFT transformations for a vector of dimension 1 and size N: |
CFFTW_DFTTranspose | This class describes Discrete Fourier Transform Transposition based on fftw library |
CFFTW_FFT | This class manages the execution of Fast Fourier Transform. several fast Fourier Transforms may be applied to a same vector of dimension D and of size N |
CFFTW_MultiDFTs | This class computes FFT transformations for a vector of dimension D and size N: |
CFFTW_MultiLevelsDFT | This class describes Multi Level DFT routines based on fftw library |
CFFTW_Object | This class is the base class of FFTW objects |
CFFTW_Plan | This class describes an FFT Plan |
CFFTW_Run | This class is the runner class for the package FFTW |
CFFTW_Test | This class describes Test class for module |
CMATH_ArrayVector | This class impements the MATH_Vector class thanks to CORE_RealArray data |
CMATH_BiConjugateGradientStabilized | This class describes a solver of Ax=b when A is not symmetric. The implementation is based on the Bi - conjugate gradient Stabilized |
CMATH_ConjugateGradient | This class describes a solver of Ax=b when A is symmetric and positive definite. The implementation is based on the conjugate gradient method |
CMATH_ConjugateGradientSquared | This class describes a solver of Ax=b when A is not symmetric. The implementation is based on the Bi - conjugate gradient without having to compute the transpose of A |
CMATH_ElementaryMultiLevelsCircularTensorToeplitzMatrix | This class is a multi level toeplitz matrix based on circular matrix whose leaf block are packed or full matrix of dimension D and whose size S is either or . In this implementation, the multi levels organization of the matrix is kept. This work is based on the article of by S. Labbe |
CMATH_ElementaryMultiLevelsCircularToeplitzMatrix | This class is a multi level toeplitz matrix based on circular matrix whose leaf block are packed or full matrix of dimension D and whose size is either or . The multi-levels toeplitz matrix is considered as a 1-level toeplitz matrix indexing by the index value where is the index of the block at level l and the number of block by rows in level l |
CMATH_ElementaryMultiLevelsPolynomialToeplitzMatrix | This class is a multi level toeplitz matrix whose leaf block are packed or full matrix of dimension D and whose size is either or . The multi-levels toeplitz matrix is considered as a one level indexing by the index value where is the index of the block at level l and the number of block by rows in level l. This work is based on the article of by D. Lee |
CMATH_ElementaryMultiLevelsToeplitzMatrix | This class is a multi level toeplitz matrix whose leaf block are packed/full matrix of dimension D and whose size is either or . The Matrix.Vector product is done by considering each element of the leaf matrix |
CMATH_FullMatrix | This class impements the MATH_Matrix class thanks to CORE_RealArray data |
CMATH_GaussLegendreIntegration | This class integrate function where a,b,t, in d=(1,2,3..) |
CMATH_GlobalMultiLevelsPolynomialToeplitzMatrix | This class is a multi level toeplitz matrix whose leaf block are dense matrix of dimension D and with size S=D x D |
CMATH_IntegrandFunction | This class describes a function to integrate. the method computeFunction() has to be defined |
CMATH_Integration | This class integrates integrand function MATH_IntegrandFunction where a,b,t,dt in d=(1,2,3..) |
CMATH_IntegrationClassFactory | This class describes a class factory to generate generic classes for the integration math module of the E-MicroM Package |
CMATH_IntegrationRun | This class is the runner class for the generic package of the integration of the math module of E-MicroM Package |
CMATH_IntegrationTest | This class is a test class for E-MicromM integration Math package |
CMATH_LeafBlockMatrixFullStorage | |
CMATH_LeafBlockMatrixPackedStorage | |
CMATH_LeafBlockMatrixStorage | |
CMATH_MaskArrayVector | This class impements the MATH_MaskVector class thanks to CORE_RealArray data |
CMATH_MaskMatrix | This class impements the MATH_MaskMatrix whci deals with mask vector |
CMATH_MaskVector | |
CMATH_Matrix | This class describes a general matrix interface used in solver |
CMATH_MorseMatrix | This class impements the MATH_Matrix class thanks to CORE_RealMorseArray data |
CMATH_MultiLevelsFFTToeplitzMatrix | This class is multi level toeplitz matrix whose product with vector is based on FFT; It delas with the Discrete Fast Fourier transform to project to toeplitz matrix into its spectral space where the matrix is diagonal. The methods: |
CMATH_MultiLevelsToeplitzMatrix | This class is multi levels toeplitz matrix. The matrix at level k is composed by toeplitz block matrices: |
CMATH_P0 | This class describes a polynom of degre 0 |
CMATH_P1 | This class describes a polynom of degre 1 |
CMATH_P2 | This class describes a polynom of degre 2 |
CMATH_P3 | This class describes a polynom of degre 3 : |
CMATH_P4 | This class describes a polynom of degre 4 |
CMATH_Pn | This class describes a polynom of degree n |
CMATH_PolynomialClassFactory | This class describes a class factory to generate generic classes for the core module of the microm Package |
CMATH_PolynomialRun | |
CMATH_PolynomialTest | This class is a test class for E-MicromM package |
CMATH_Solver | This class describes a solver of Ax=b |
CMATH_SolverClassFactory | This class describes a class factory to generate generic classes for the core module of the microm Package |
CMATH_SolverRun | This class is the runner class for the generic package of the math/solver module of microm Package |
CMATH_SolverTest | This class is a test class for the math solver package of E-MicroM code |
CMATH_TestFunction | This class describes a test function to integrate |
CMATH_ToeplitzClassFactory | This class describes a class factory to generate generic classes for the core module of the microm Package |
CMATH_ToeplitzRun | This class is the runner class for the generic package of the math/toeplitz module of microm Package |
CMATH_ToeplitzTest | This class is a test class for math toeplitz package of the E-MicroM code |
CMATH_Vector | This class describes a masked vector |
CMATSGN_Complex | This class describes complex based on fftw_complex sructure |
CMATSGN_ComplexArray | This class describes FFT complex array based on fft_complex structure |
CMATSGN_FFT | This class describes FFT routines based on fftw_complex array used in fftw library |
CMATSGN_Test | This class describes Test class for module |
CNRFunction | |
CnullDeleter | |
COMP_ArrayElement | |
COMP_Thread | This class describes an Open MP process |