C++ main module for emicrom Package  1.0
Public Member Functions | Static Public Member Functions | Static Public Attributes | Protected Member Functions | Private Member Functions | List of all members
EMMG_UniaxialAnisotropyOperator Class Reference

This class describes an implementation the uniaxial anistropy operator EMM_UniaxialAnisotropyOPerator of the landau lifschitz system EMM_LandauLifschitzSystem based on EMMG_RealField. More...

#include <EMMG_UniaxialAnisotropyOperator.h>

Inheritance diagram for EMMG_UniaxialAnisotropyOperator:
Inheritance graph
[legend]
Collaboration diagram for EMMG_UniaxialAnisotropyOperator:
Collaboration graph
[legend]

Public Member Functions

void computeMagneticExcitationField (const EMM_RealArray &sigma, const EMM_RealField &M, EMM_RealField &H) const
 compute the normalized excitation magnetic field at M for reading More...
 
virtual tULLInt getMemorySize () const
 return the memory size in byte More...
 
virtual tBoolean discretize (const EMM_LandauLifschitzSystem &system)
 discretize the operator depending on method More...
 
virtual tBoolean isAffine () const
 return true if the operator is either constant or linear More...
 
virtual tBoolean isGradientComputationable () const
 return true if the gradient of the magnetic excitation is computationable More...
 
virtual tBoolean resetToInitialState (const EMM_LandauLifschitzSystem &system)
 reset the data of the operator to its initial step t=0 More...
 
virtual tBoolean computeFieldsAtTime (const tReal &t, const tFlag &order, const EMM_RealArray &sigma, const EMM_RealField &dM_dt0, const EMM_RealField &M0)
 compute the fields of operator at time More...
 
virtual tBoolean updateAtNextTimeStep (const tReal &dt, const EMM_RealArray &sigma, const EMM_RealField &Mt)
 update the data of operator at next time step More...
 
virtual tBoolean computeMagneticExcitationFieldGradient (const EMM_RealArray &sigma, const EMM_RealField &M, const EMM_RealField &D, EMM_RealField &gradH) const
 compute the gradient of the magnetic excitation field at M in the direction D More...
 
virtual tReal computeEnergy (const tReal &t, const EMM_RealArray &sigma, const EMM_RealField &Mt, EMM_RealField &W) const
 compute the energy E of the operator More...
 
tReal computeMagneticExcitationFieldAndEnergy (const tReal &t, const EMM_RealArray &sigma, const EMM_RealField &Mt, EMM_RealField &Ht) const
 compute the energy of the operator More...
 
virtual tString getName () const
 return an human reading name of the operator More...
 
const tBooleanisCubicVolume () const
 return the true if the element is cubic More...
 
const tRealgetElementVolume () const
 return the adimensionized volume of the element More...
 
virtual void adimensionize (const tReal &Le, const tReal &Ms, const tReal &T, const tReal &L)
 adimensionize the operator More...
 
virtual tUSInt getDataFieldsNumber () const
 get the number of feild used in the operator More...
 
virtual tBoolean getDataFieldSpace (const tUSInt &index, tString &dataName, tFlag &supportType, tString &dFieldType, tUIndex &n, tDimension &dim) const
 get the data field at index for saving data in vtk,txt,... files. More...
 
virtual tBoolean getDataField (const tUSInt &index, tString &dataName, tUIndex &n, tDimension &dim, const float *&values) const
 get the data field at index for saving data in vtk,txt,... files. More...
 
virtual tBoolean getDataField (const tUSInt &index, tString &dataName, tUIndex &n, tDimension &dim, const double *&values) const
 get the data field at index for saving data in vtk,txt,... files. More...
 
virtual tBoolean getDataField (const tUSInt &index, tString &dataName, tUIndex &n, tDimension &dim, const long double *&values) const
 get the data field at index for saving data in vtk,txt,... files. More...
 
virtual tBoolean backup (const tString &prefix, const tString &suffix, const tString &ext) const
 backup of the operator data into file(s) used for restoring More...
 
virtual tBoolean restore (const EMM_LandauLifschitzSystem &system, const tString &prefix, const tString &suffix, const tString &ext)
 restore the operator data from file(s) More...
 
void getSharedPointer (SP::CORE_Object &p)
 get the shared pointer of this class into p More...
 
void getSharedPointer (SPC::CORE_Object &p) const
 get the shared pointer of this class into p More...
 
tString getClassName () const
 return the class name of the object More...
 
tString getIdentityString () const
 return the identity string of the object of the form className_at_address More...
 
tString getPointerAddress () const
 return the identity string of the object More...
 
template<class T >
tBoolean isInstanceOf () const
 test if the clas T is an instance of this class More...
 
tBoolean isInstanceOf (const tString &name) const
 test if the object is an instance of className More...
 
virtual tString toString () const
 return the string representation of the object node More...
 

Static Public Member Functions

static SP::EMMG_UniaxialAnisotropyOperator New ()
 create a uniaxial anisotropy operator More...
 
static tUSInt BuildDiscretizedMatrix (const tUCInt &nU, const tReal *U, tReal *A)
 
static tUSInt ComputeMagneticExcitation (const tReal &KS, const tReal *A, const tDimension &dim, const tReal *M, tReal *H)
 compute the magnetic excitation at cell i More...
 
static void ComputeEnergy (const tReal &S, const tDimension &dim, const tReal *M, const tReal *H, tReal &E)
 compute the energy of the cell i for linear operator More...
 
static void setIsMemoryChecked (const tBoolean &v)
 set if the memory checking is used More...
 
static void setOut (SP::CORE_Out out)
 set the output stream More...
 
static void resetOut ()
 reset the output stream More...
 
static void setThread (SP::CORE_Thread thread)
 set the thread More...
 
static void resetThread ()
 reset the output stream More...
 
static CORE_Outout ()
 get the output More...
 
static SP::CORE_Out getOut ()
 get the output More...
 
static CORE_ThreadgetThread ()
 get the profilier More...
 
static const tBooleanisMemoryChecked ()
 get if the memory checking is used More...
 
static tString getClassName (const tString &identityString)
 return the class name of the object More...
 
template<class T >
static tString getTypeName ()
 get type name More...
 
static tBoolean is64Architecture ()
 return true if the machine is a 64 bits machine More...
 
static tBoolean is32Architecture ()
 return true if the machine is a 32 bits machine More...
 
static tString pointer2String (const void *obj)
 return the string representation of a pointer More...
 
static void printObjectsInMemory (ostream &f)
 print object in memory More...
 
static void printObjectsInMemory ()
 print object in memory in the standart output More...
 
static tChar getMaxChar ()
 get the max value for tChar type More...
 
static tChar getMinChar ()
 get the min value for tChar type More...
 
static tUChar getMaxUChar ()
 get the max value for tUChar type More...
 
static tUChar getMinUChar ()
 get the min value for tUChar type More...
 
static tSInt getMaxSInt ()
 get the max value for tSInt type More...
 
static tSInt getMinSInt ()
 get the min value for tSInt type More...
 
static tUSInt getMaxUSInt ()
 get the max value for tUSInt type More...
 
static tUSInt getMinUSInt ()
 get the min value for tUSInt type More...
 
static tInt getMaxInt ()
 get the max value for tInt type More...
 
static tInt getMinInt ()
 get the min value for tInt type More...
 
static tUInt getMaxUInt ()
 get the max value for tUInt type More...
 
static tUInt getMinUInt ()
 get the min value for tUInt type More...
 
static tLInt getMaxLInt ()
 get the max value for tLInt type More...
 
static tLInt getMinLInt ()
 get the min value for tLInt type More...
 
static tULInt getMaxULInt ()
 get the max value for tULInt type More...
 
static tULInt getMinULInt ()
 get the min value for tULInt type More...
 
static tLLInt getMaxLLInt ()
 get the max value for tULInt type More...
 
static tLLInt getMinLLInt ()
 get the min value for tLLInt type More...
 
static tULLInt getMaxULLInt ()
 get the max value for tULLInt type More...
 
static tULLInt getMinULLInt ()
 get the min value for tULLInt type More...
 
static tFloat getMaxFloat ()
 get the max value for tFloat type More...
 
static tFloat getMinFloat ()
 get the min value for tFloat type More...
 
template<class T >
static T getEpsilon ()
 get the epsilon value for T type More...
 
template<class T >
static T getInfinity ()
 get the infinity for T type More...
 
static tFloat getFloatEpsilon ()
 get the epsilon value for tFloat type More...
 
static tFloat getFloatInfinity ()
 get the infinity value for tFloat type More...
 
static tDouble getMaxDouble ()
 get the max value for tDouble type More...
 
static tDouble getMinDouble ()
 get the min value for tDouble type More...
 
static tDouble getDoubleInfinity ()
 get the infinity value for tFloat type More...
 
static tDouble getDoubleEpsilon ()
 get the epsilon value for tDouble type More...
 
static tLDouble getMinLDouble ()
 get the min value for tLDouble type More...
 
static tLDouble getMaxLDouble ()
 get the max value for tLDouble type More...
 
static tLDouble getLDoubleEpsilon ()
 get the epsilon value for tLDouble type More...
 
static tDouble getLDoubleInfinity ()
 get the infinity value for tDouble type More...
 
static tIndex getMaxIndex ()
 get the max value for the array/vector indexing type More...
 
static tIndex getMinIndex ()
 get the min value for the array/vector indexing type More...
 
static tUIndex getMaxUIndex ()
 get the max value for difference the array/vector indexing type More...
 
static tUIndex getMinUIndex ()
 get the min value for difference the array/vector indexing type More...
 
static tFlag getMaxFlag ()
 get the max value for the tFlag type More...
 
static tFlag getMinFlag ()
 get the min value for the tFlag type More...
 
static tUInteger getMaxUInteger ()
 get the max value for the unsigned integer type More...
 
static tUInteger getMinUInteger ()
 get the min value for the unsigned integer type More...
 
static tInteger getMaxInteger ()
 get the max value for the integer type More...
 
static tInteger getMinInteger ()
 get the min value for the integer type More...
 
static tReal getMaxReal ()
 get the max value for the real type More...
 
static tReal getMinReal ()
 get the min value for the real type More...
 
static tReal getRealEpsilon ()
 get the eps which is the difference between 1 and the least value greater than 1 that is representable. More...
 
static tReal getRealInfinity ()
 get the infinity value More...
 
template<class T >
static T computeEpsilon ()
 compute epsilon More...
 

Static Public Attributes

static const tReal Mu0 =4*M_PI*1e-07
 
static const tReal Gamma =-1.7e11
 
static const tDimension X =0
 
static const tDimension Y =1
 
static const tDimension Z =2
 
static const tReal NULL_VALUE [] ={0,0,0}
 

Protected Member Functions

 EMMG_UniaxialAnisotropyOperator (void)
 create More...
 
virtual ~EMMG_UniaxialAnisotropyOperator (void)
 destroy More...
 
virtual void buildAnisotropyMatrix (const tUIndex &nCells, const EMM_Grid3D &mesh, const CORE_UCharMorseArray &crystal, const CORE_RealMorseArray &directions, CORE_RealMorseArray &A) const
 compute the anistropy matrix More...
 
virtual void computeMagneticExcitationField (const tUIndex &nCells, const tDimension &dim, const EMM_RealArray &sigma, const tReal *M, tReal *H) const
 compute the normalized excitation magnetic field at M when anisotropy directions is uniform More...
 
virtual tReal computeEnergyWithMagneticExcitation (const tReal &t, const EMM_RealArray &sigma, const EMM_RealField &Mt, const EMM_RealField &Ht) const
 compute the energy E of the operator More...
 
virtual void toDoAfterThisSetting ()
 method called after the setting of the shared pointer this method can only be called once. More...
 
void setThis (SP::CORE_Object p)
 set this weak shared pointer called toDoAfterThis setting method More...
 

Private Member Functions

 SP_OBJECT (EMMG_UniaxialAnisotropyOperator)
 

Detailed Description

This class describes an implementation the uniaxial anistropy operator EMM_UniaxialAnisotropyOPerator of the landau lifschitz system EMM_LandauLifschitzSystem based on EMMG_RealField.

Author
Stéphane Despréaux
Version
1.0

Constructor & Destructor Documentation

◆ EMMG_UniaxialAnisotropyOperator()

EMMG_UniaxialAnisotropyOperator::EMMG_UniaxialAnisotropyOperator ( void  )
inlineprotected

create

Referenced by New().

Here is the caller graph for this function:

◆ ~EMMG_UniaxialAnisotropyOperator()

virtual EMMG_UniaxialAnisotropyOperator::~EMMG_UniaxialAnisotropyOperator ( void  )
inlineprotectedvirtual

destroy

Member Function Documentation

◆ adimensionize()

virtual void EMM_Operator::adimensionize ( const tReal Le,
const tReal Ms,
const tReal T,
const tReal L 
)
inlinevirtualinherited

adimensionize the operator

Parameters
[in]Leadimensionizing parameter
[in]Msmagnetization at saturation
[in]Tcaracterictic time
[in]Lcaracteristic length

Do nothing by default

Reimplemented in EMM_MagnetostrictionOperator, and EMM_DisplacementOperator.

References EMM_Operator::discretize(), EMM_Operator::resetToInitialState(), and tBoolean.

Here is the call graph for this function:

◆ backup()

virtual tBoolean EMM_Operator::backup ( const tString prefix,
const tString suffix,
const tString ext 
) const
inlinevirtualinherited

backup of the operator data into file(s) used for restoring

Parameters
prefix: common prefix of the saving files
suffix: common suffix of the saving files
ext: common extension of the saving files
Returns
true: do nothing by default

Reimplemented in EMM_DisplacementOperator, EMM_MagnetostrictionOperator, and EMM_DisplacementFVMOperator.

◆ buildAnisotropyMatrix()

void EMM_LinearAnisotropyOperator::buildAnisotropyMatrix ( const tUIndex nCells,
const EMM_Grid3D mesh,
const CORE_UCharMorseArray crystal,
const CORE_RealMorseArray directions,
CORE_RealMorseArray A 
) const
protectedvirtualinherited

compute the anistropy matrix

Parameters
nCellsnumber of cells
meshmesh of the operator
crystalcrystal type for each magnetized cell or constant for all magnetized cells (array's size is 1)
directionsmorse array for directions for each magnetized cell or constant for all cells and all the cells is magnetized (array's size is 1)
A: the morse matrix to built

The anisotropy matrix is a Morse Array of size nCells x 6 containing the anisotropy matrix for only magnetized cells.

For building the anisotropy matrix at the cell i, it calls the static methods depending on the crystal type :

  • EMM_UniaxialAnisotropyOperator::BuildAnisotropyMatrix()
  • EMM_PlanarAnisotropyOperator::BuildAnisotropyMatrix()
  • EMM_CubixAnisotropyOperator::BuildAnisotropyMatrix()

References CORE_MorseArray< T >::begin(), EMM_PlanarAnisotropyOperator::BuildDiscretizedMatrix(), EMM_UniaxialAnisotropyOperator::BuildDiscretizedMatrix(), CORE_MorseArray< T >::getIndexIncrement(), EMM_Grid3D::getNeighborsIndicators(), EMM_Grid3D::IS_ELEMENT_MAGNETIZED(), CORE_MorseArray< T >::merge(), OMP_GET_THREAD_ID, OMP_GET_THREADS_NUMBER, OMP_PARALLEL, OMP_PARALLEL_PRIVATE_SHARED_DEFAULT, EMM_Matter::PLANAR_ANISOTROPY, CORE_MorseArray< T >::reset(), CORE_MorseArrayIterator< T >::setSize(), CORE_MorseArray< T >::setSize(), CORE_MorseArrayConstIterator< T >::size(), tBoolean, tCellFlag, tUCInt, tUIndex, tUInteger, tUSInt, EMM_Matter::UNIAXIAL_ANISOTROPY, CORE_MorseArray< T >::uniformize(), CORE_MorseArrayIterator< T >::values(), and CORE_MorseArrayConstIterator< T >::values().

Referenced by EMM_LinearAnisotropyOperator::getMemorySize().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ BuildDiscretizedMatrix()

static tUSInt EMM_UniaxialAnisotropyOperator::BuildDiscretizedMatrix ( const tUCInt nU,
const tReal U,
tReal A 
)
inlinestaticinherited

References tDimension, CORE_Integer::toString(), and tReal.

Referenced by EMM_LinearAnisotropyOperator::buildAnisotropyMatrix(), and EMM_AnisotropyOperator::buildAnisotropyMatrix().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ computeEnergy()

virtual tReal EMM_MagneticExcitationLinearOperator::computeEnergy ( const tReal t,
const EMM_RealArray sigma,
const EMM_RealField Mt,
EMM_RealField W 
) const
inlinevirtualinherited

compute the energy E of the operator

Parameters
tthe time in [0,dt[ where dt is the time step
sigmathe weight of each element
Mtthe normalized magnetization field
Wa working array
Returns
the energy of the operator

compute the energy E which verifies the general relation:

  • W contains the mangnetic excitation at Mt
  • $ \displaystyle \frac{dE}{dM} \cdot \delta (M_t) = \displaystyle -2 H(M_t) \cdot \delta $

Implements EMM_MagneticExcitationOperator.

References EMM_MagneticExcitationOperator::computeMagneticExcitationFieldAndEnergy().

Here is the call graph for this function:

◆ ComputeEnergy()

void EMM_LinearAnisotropyOperator::ComputeEnergy ( const tReal S,
const tDimension dim,
const tReal M,
const tReal H,
tReal E 
)
staticinherited

compute the energy of the cell i for linear operator

Parameters
Sweight walue
dimmemory size of Mi
MM values
HH values
Eenergy value

E=- S. M.H on normalized volume cell

at return

  • M pointer is moved of dim elements
  • H pointer is moved of dim elements

References tReal, and tUSInt.

Referenced by EMM_AnisotropyOperator::computeEnergyWithMagneticExcitation(), and EMM_LinearAnisotropyOperator::getMemorySize().

Here is the caller graph for this function:

◆ computeEnergyWithMagneticExcitation()

virtual tReal EMM_MagneticExcitationLinearOperator::computeEnergyWithMagneticExcitation ( const tReal t,
const EMM_RealArray sigma,
const EMM_RealField Mt,
const EMM_RealField Ht 
) const
inlineprotectedvirtualinherited

compute the energy E of the operator

Parameters
tthe time in [0,dt[ where dt is the time step
sigmathe weight of each element
Mt: the normalized magnetization field
Ht: the magnetic excitation field
Returns
the enery of the operator

compute the energy:

$ E= - \displaystyle . \sum_i \int_{\omega_i} \sigma_i H_i . M_i dx = vol. \sum_i . \sigma_i . \sum_{k=0}^{k=3} \left (H^k_i . M^k_i \right )$ in the normalized domain $ \omega_i $

E verifies the general relation:

$ \displaystyle \frac{dE}{dM} \cdot \delta= \displaystyle -2 \sum_i \int_{\omega_i} \sigma_i H(M) \cdot \delta d\omega_i $

Implements EMM_MagneticExcitationOperator.

References EMM_RealField::dot(), and EMM_Operator::getElementVolume().

Here is the call graph for this function:

◆ computeEpsilon()

template<class T >
static T CORE_Object::computeEpsilon ( )
inlinestaticinherited

compute epsilon

Returns
the epsilon value eps=10^{-p/3} where p is defined by getEpsilon()=10^{-p}

◆ computeFieldsAtTime()

virtual tBoolean EMM_MagneticExcitationLinearOperator::computeFieldsAtTime ( const tReal t,
const tFlag order,
const EMM_RealArray sigma,
const EMM_RealField dM_dt0,
const EMM_RealField M0 
)
inlinevirtualinherited

compute the fields of operator at time

Parameters
tthe time
orderorder of integration of the fields with respect of time 1 or 2
sigmathe magnetized weight of each cell
dM_dt0the variation of M at time 0
M0the M at time 0
Returns
true Do nothing : no fields

Implements EMM_Operator.

◆ ComputeMagneticExcitation()

tUSInt EMM_LinearAnisotropyOperator::ComputeMagneticExcitation ( const tReal KS,
const tReal A,
const tDimension dim,
const tReal M,
tReal H 
)
staticinherited

compute the magnetic excitation at cell i

Parameters
KSweight * first anisotropy constant
Aanisotropy matrix of size 6
dimmemory size of M,H
MM values
HH values

It computes the magnetic excitation of cell I with its matrix representation A :

$ H_i=A_i . M_i $ where $ A_i $ is the pack symmetric anisotropy 3x3 matrix of the cell i

Returns
the displacement size of A matrix ldA

References tDimension, and tReal.

Referenced by EMM_AnisotropyOperator::computeMagneticExcitationField(), EMM_AnisotropyOperator::computeMagneticExcitationFieldGradient(), and EMM_LinearAnisotropyOperator::getMemorySize().

Here is the caller graph for this function:

◆ computeMagneticExcitationField() [1/2]

void EMMG_UniaxialAnisotropyOperator::computeMagneticExcitationField ( const EMM_RealArray sigma,
const EMM_RealField M,
EMM_RealField H 
) const
inlinevirtual

compute the normalized excitation magnetic field at M for reading

Parameters
sigmathe weight of the normalized magnetization for each cell
Mnormalized magnetization field
Hreturn excitation magnetic field

Implements EMM_MagneticExcitationOperator.

References EMM_LinearAnisotropyOperator::computeMagneticExcitationField(), EMM_RealField::getDimension(), EMM_RealField::getSize(), null, EMM_RealField::setDimension(), EMM_RealField::setSize(), tDimension, and tUIndex.

Here is the call graph for this function:

◆ computeMagneticExcitationField() [2/2]

void EMM_LinearAnisotropyOperator::computeMagneticExcitationField ( const tUIndex nCells,
const tDimension dim,
const EMM_RealArray sigma,
const tReal M,
tReal H 
) const
protectedvirtualinherited

compute the normalized excitation magnetic field at M when anisotropy directions is uniform

Parameters
nCellsnumber of cells of the mesh
dimdimension of each point of the mesh
sigmaweight of magnetism vector at each cell
Mnormalized magnetization field values at each cell
Hreturn excitation magnetic field values at each cell

It computes : $ H_i= sigma. K1. A_i. M_i $ where f_i is a factor of the 3x3 packed symmetric matrix $ A_i $

References CORE_MorseArray< T >::begin(), CORE_MorseArray< T >::getIndexIncrement(), CORE_Array< T >::getSize(), CORE_Object::getThread(), EMM_LinearAnisotropyOperator::mA, EMM_LinearAnisotropyOperator::mK1, OMP_GET_THREAD_ID, OMP_GET_THREADS_NUMBER, OMP_PARALLEL, OMP_PARALLEL_PRIVATE_SHARED_DEFAULT, CORE_MorseArrayConstIterator< T >::size(), CORE_Thread::startChrono(), CORE_Thread::stopChrono(), tBoolean, tDimension, tReal, tUIndex, tUInteger, and CORE_MorseArrayConstIterator< T >::values().

Referenced by EMMG_PlanarAnisotropyOperator::computeMagneticExcitationField(), EMMG_LinearAnisotropyOperator::computeMagneticExcitationField(), computeMagneticExcitationField(), and EMM_LinearAnisotropyOperator::getMemorySize().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ computeMagneticExcitationFieldAndEnergy()

tReal EMM_MagneticExcitationOperator::computeMagneticExcitationFieldAndEnergy ( const tReal t,
const EMM_RealArray sigma,
const EMM_RealField Mt,
EMM_RealField Ht 
) const
inlineinherited

compute the energy of the operator

Parameters
ttime in [0,dt[ where dt will be the next time step
sigmaweight of each cell
Mtthe magnetization field
Htthe return magnetic excitation field
Returns
the energy
  • compute Ht=H(Mt)
  • compute energy of the operator

References EMM_MagneticExcitationOperator::computeEnergy(), EMM_MagneticExcitationOperator::computeEnergyWithMagneticExcitation(), EMM_MagneticExcitationOperator::computeMagneticExcitationField(), and tReal.

Referenced by EMM_MagneticExcitationLinearOperator::computeEnergy(), and EMMG_AnisotropyOperator::computeEnergy().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ computeMagneticExcitationFieldGradient()

virtual tBoolean EMM_MagneticExcitationLinearOperator::computeMagneticExcitationFieldGradient ( const EMM_RealArray sigma,
const EMM_RealField M,
const EMM_RealField D,
EMM_RealField gradH 
) const
inlinevirtualinherited

compute the gradient of the magnetic excitation field at M in the direction D

Parameters
sigmathe weight of element
Mthe magnetization field
Dthe gradient direction
gradH: the return gradient of the magnetic excitation field at M in the direction D
Returns
false because the gradient is null

gradH is unchanged

Implements EMM_MagneticExcitationOperator.

References EMM_MagneticExcitationOperator::computeMagneticExcitationField().

Here is the call graph for this function:

◆ discretize()

tBoolean EMM_LinearAnisotropyOperator::discretize ( const EMM_LandauLifschitzSystem system)
virtualinherited

discretize the operator depending on method

Parameters
systemlandau lifschitz system used to discretize the operator
Returns
true if the discretization succeeds

Reimplemented from EMM_Operator.

References EMM_Matter::CRYSTAL_TYPE, EMM_Grid3D::getElementsNumber(), EMM_LandauLifschitzSystem::getMatterField(), EMM_MatterField::getMatterParameterDistribution(), EMM_LandauLifschitzSystem::getMesh(), CORE_Object::getThread(), CORE_MorseArray< T >::isConstant(), EMM_Matter::K1d, EMM_LinearAnisotropyOperator::mK1, CORE_MorseArray< T >::setUniformSize(), CORE_Thread::startChrono(), and tUIndex.

Referenced by EMM_LinearAnisotropyOperator::getMemorySize().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ getClassName() [1/2]

tString CORE_Object::getClassName ( ) const
inherited

return the class name of the object

Returns
the class name of the object

References tString.

Referenced by CORE_Object::getIdentityString(), EMM_Operator::getName(), and CORE_Object::isMemoryChecked().

Here is the caller graph for this function:

◆ getClassName() [2/2]

static tString CORE_Object::getClassName ( const tString identityString)
inlinestaticinherited

return the class name of the object

Parameters
identityStringthe identity string of the object
Returns
the class name

◆ getDataField() [1/3]

virtual tBoolean EMM_Operator::getDataField ( const tUSInt index,
tString dataName,
tUIndex n,
tDimension dim,
const float *&  values 
) const
inlinevirtualinherited

get the data field at index for saving data in vtk,txt,... files.

Parameters
indexindex of the field in [0,getDataFieldsNumber()[
dataNamename of the field
nnumber of element of the field
dimdimension of the field in [1,3[
valuesvalues of the field
Returns
true if the field at index exists

Reimplemented in EMM_DisplacementOperator, EMM_MagnetostrictionOperator, and EMM_ZeemanOperator.

Referenced by EMM_OperatorsTest::compareDiscretizedData().

Here is the caller graph for this function:

◆ getDataField() [2/3]

virtual tBoolean EMM_Operator::getDataField ( const tUSInt index,
tString dataName,
tUIndex n,
tDimension dim,
const double *&  values 
) const
inlinevirtualinherited

get the data field at index for saving data in vtk,txt,... files.

Parameters
indexindex of the field in [0,getDataFieldsNumber()[
dataNamename of the field
nnumber of element of the field
dimdimension of the field in [1,3[
valuesvalues of the field
Returns
true if the field at index exists

Reimplemented in EMM_DisplacementOperator, EMM_MagnetostrictionOperator, and EMM_ZeemanOperator.

◆ getDataField() [3/3]

virtual tBoolean EMM_Operator::getDataField ( const tUSInt index,
tString dataName,
tUIndex n,
tDimension dim,
const long double *&  values 
) const
inlinevirtualinherited

get the data field at index for saving data in vtk,txt,... files.

Parameters
indexindex of the field in [0,getDataFieldsNumber()[
dataNamename of the field
nnumber of element of the field
dimdimension of the field in [1,3[
valuesvalues of the field
Returns
true if the field at index exists

Reimplemented in EMM_DisplacementOperator, EMM_MagnetostrictionOperator, and EMM_ZeemanOperator.

◆ getDataFieldsNumber()

virtual tUSInt EMM_Operator::getDataFieldsNumber ( ) const
inlinevirtualinherited

get the number of feild used in the operator

Returns
the number of data

Reimplemented in EMM_DisplacementOperator, EMM_MagnetostrictionOperator, EMM_ZeemanOperator, and EMMG_SLDemagnetizedOperator.

◆ getDataFieldSpace()

virtual tBoolean EMM_Operator::getDataFieldSpace ( const tUSInt index,
tString dataName,
tFlag supportType,
tString dFieldType,
tUIndex n,
tDimension dim 
) const
inlinevirtualinherited

get the data field at index for saving data in vtk,txt,... files.

Parameters
indexindex of the field in [0,getDataFieldsNumber()[
dataNamename of the field
supportType: mesh element whre the field is applied EMM_Grid3D::ELEMENT or EMM_Grid3D::POINT
dFieldType: type of the field double,float,int,....
nnumber of element of the field
dimdimension of the field in [1,3[
Returns
true if the field at index exists

Reimplemented in EMM_DisplacementFEMOperator, EMM_DisplacementFVMOperator, EMM_MagnetostrictionOperator, and EMM_ZeemanOperator.

References EMM_Grid3D::ELEMENT.

◆ getDoubleEpsilon()

static tDouble CORE_Object::getDoubleEpsilon ( )
inlinestaticinherited

get the epsilon value for tDouble type

Returns
the epsilon value for tDouble type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getDoubleInfinity()

static tDouble CORE_Object::getDoubleInfinity ( )
inlinestaticinherited

get the infinity value for tFloat type

Returns
the intinity value for tFloat type

◆ getElementVolume()

const tReal& EMM_Operator::getElementVolume ( ) const
inlineinherited

◆ getEpsilon()

template<class T >
static T CORE_Object::getEpsilon ( )
inlinestaticinherited

get the epsilon value for T type

Returns
the epsilon value for T type

◆ getFloatEpsilon()

static tFloat CORE_Object::getFloatEpsilon ( )
inlinestaticinherited

get the epsilon value for tFloat type

Returns
the epsilon value for tFloat type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getFloatInfinity()

static tFloat CORE_Object::getFloatInfinity ( )
inlinestaticinherited

get the infinity value for tFloat type

Returns
the intinity value for tFloat type

◆ getIdentityString()

tString CORE_Object::getIdentityString ( ) const
inlineinherited

◆ getInfinity()

template<class T >
static T CORE_Object::getInfinity ( )
inlinestaticinherited

get the infinity for T type

Returns
the infinity value for T type

◆ getLDoubleEpsilon()

static tLDouble CORE_Object::getLDoubleEpsilon ( )
inlinestaticinherited

get the epsilon value for tLDouble type

Returns
the epsilon value for tLDouble type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getLDoubleInfinity()

static tDouble CORE_Object::getLDoubleInfinity ( )
inlinestaticinherited

get the infinity value for tDouble type

Returns
the infinity value for tDouble type

◆ getMaxChar()

static tChar CORE_Object::getMaxChar ( )
inlinestaticinherited

get the max value for tChar type

Returns
the max value for tChar type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxDouble()

static tDouble CORE_Object::getMaxDouble ( )
inlinestaticinherited

get the max value for tDouble type

Returns
the max value for tDouble type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxFlag()

static tFlag CORE_Object::getMaxFlag ( )
inlinestaticinherited

get the max value for the tFlag type

Returns
the max value for the tFlag type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxFloat()

static tFloat CORE_Object::getMaxFloat ( )
inlinestaticinherited

get the max value for tFloat type

Returns
the max value for tFloat type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxIndex()

static tIndex CORE_Object::getMaxIndex ( )
inlinestaticinherited

get the max value for the array/vector indexing type

Returns
the max value for the array/vector indexing type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxInt()

static tInt CORE_Object::getMaxInt ( )
inlinestaticinherited

get the max value for tInt type

Returns
the max value for tInt type

Referenced by MATSGN_FFT::fastFourierTransform3D_FFTW(), and CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxInteger()

static tInteger CORE_Object::getMaxInteger ( )
inlinestaticinherited

get the max value for the integer type

Returns
the max value for the integer type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxLDouble()

static tLDouble CORE_Object::getMaxLDouble ( )
inlinestaticinherited

get the max value for tLDouble type

Returns
the max value for tLDouble type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxLInt()

static tLInt CORE_Object::getMaxLInt ( )
inlinestaticinherited

get the max value for tLInt type

Returns
the max value for tLInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxLLInt()

static tLLInt CORE_Object::getMaxLLInt ( )
inlinestaticinherited

get the max value for tULInt type

Returns
the max value for tULInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxReal()

static tReal CORE_Object::getMaxReal ( )
inlinestaticinherited

get the max value for the real type

Returns
he max value for the real type

Referenced by EMM_MatterField::adimensionize(), and CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxSInt()

static tSInt CORE_Object::getMaxSInt ( )
inlinestaticinherited

get the max value for tSInt type

Returns
the max value for tSInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxUChar()

static tUChar CORE_Object::getMaxUChar ( )
inlinestaticinherited

get the max value for tUChar type

Returns
the max value for tUChar type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxUIndex()

static tUIndex CORE_Object::getMaxUIndex ( )
inlinestaticinherited

get the max value for difference the array/vector indexing type

Returns
the max value for difference the array/vector indexing type

Referenced by CORE_Vector< T >::addAfterIndices(), CORE_Vector< T >::search(), CORE_Test::testType(), CORE_Integer::toHexString(), and CORE_Integer::toString().

Here is the caller graph for this function:

◆ getMaxUInt()

static tUInt CORE_Object::getMaxUInt ( )
inlinestaticinherited

get the max value for tUInt type

Returns
the max value for tUInt type

Referenced by EMM_Array< tCellFlag >::loadFromFile(), EMM_RealField::loadFromFile(), and CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxUInteger()

static tUInteger CORE_Object::getMaxUInteger ( )
inlinestaticinherited

get the max value for the unsigned integer type

Returns
the max value for the unsigned integer type

Referenced by MATH_Pn::computeExtrenums(), EMM_MultiScaleGrid::computeLevelsNumber(), EMM_Input::restoreBackup(), MATH_P0::solve(), and CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxULInt()

static tULInt CORE_Object::getMaxULInt ( )
inlinestaticinherited

get the max value for tULInt type

Returns
the max value for tULInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxULLInt()

static tULLInt CORE_Object::getMaxULLInt ( )
inlinestaticinherited

get the max value for tULLInt type

Returns
the max value for tULLInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMaxUSInt()

static tUSInt CORE_Object::getMaxUSInt ( )
inlinestaticinherited

get the max value for tUSInt type

Returns
the max value for tUSInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMemorySize()

virtual tULLInt EMM_LinearAnisotropyOperator::getMemorySize ( ) const
inlinevirtualinherited

return the memory size in byte

Returns
the memory size of the storage in bytes 1 Kb = 1024 bytes 1 Mb = 1024 Kb 1 Gb = 1024 Mb 1 Tb = 1024 Gb 1 Hb = 1024 Tb

Reimplemented from EMM_Operator.

References EMM_LinearAnisotropyOperator::buildAnisotropyMatrix(), EMM_LinearAnisotropyOperator::ComputeEnergy(), EMM_LinearAnisotropyOperator::ComputeMagneticExcitation(), EMM_LinearAnisotropyOperator::computeMagneticExcitationField(), EMM_LinearAnisotropyOperator::discretize(), EMM_Operator::getMemorySize(), CORE_MorseArray< T >::getMemorySize(), tBoolean, tDimension, tReal, tUIndex, and tUSInt.

Here is the call graph for this function:

◆ getMinChar()

static tChar CORE_Object::getMinChar ( )
inlinestaticinherited

get the min value for tChar type

Returns
the min value for tChar type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinDouble()

static tDouble CORE_Object::getMinDouble ( )
inlinestaticinherited

get the min value for tDouble type

Returns
the min value for tDouble type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinFlag()

static tFlag CORE_Object::getMinFlag ( )
inlinestaticinherited

get the min value for the tFlag type

Returns
the min value for the tFlag type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinFloat()

static tFloat CORE_Object::getMinFloat ( )
inlinestaticinherited

get the min value for tFloat type

Returns
the min value for tFloat type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinIndex()

static tIndex CORE_Object::getMinIndex ( )
inlinestaticinherited

get the min value for the array/vector indexing type

Returns
the min value for the array/vector indexing type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinInt()

static tInt CORE_Object::getMinInt ( )
inlinestaticinherited

get the min value for tInt type

Returns
the min value for tInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinInteger()

static tInteger CORE_Object::getMinInteger ( )
inlinestaticinherited

get the min value for the integer type

Returns
the minin value for the integer type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinLDouble()

static tLDouble CORE_Object::getMinLDouble ( )
inlinestaticinherited

get the min value for tLDouble type

Returns
the min value for tLDouble type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinLInt()

static tLInt CORE_Object::getMinLInt ( )
inlinestaticinherited

get the min value for tLInt type

Returns
the min value for tLInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinLLInt()

static tLLInt CORE_Object::getMinLLInt ( )
inlinestaticinherited

get the min value for tLLInt type

Returns
the min value for tLLInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinReal()

static tReal CORE_Object::getMinReal ( )
inlinestaticinherited

get the min value for the real type

Returns
the min value for the real type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinSInt()

static tSInt CORE_Object::getMinSInt ( )
inlinestaticinherited

get the min value for tSInt type

Returns
the min value for tSInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinUChar()

static tUChar CORE_Object::getMinUChar ( )
inlinestaticinherited

get the min value for tUChar type

Returns
the min value for tUChar type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinUIndex()

static tUIndex CORE_Object::getMinUIndex ( )
inlinestaticinherited

get the min value for difference the array/vector indexing type

Returns
the min value for difference the array/vector indexing type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinUInt()

static tUInt CORE_Object::getMinUInt ( )
inlinestaticinherited

get the min value for tUInt type

Returns
the min value for tUInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinUInteger()

static tUInteger CORE_Object::getMinUInteger ( )
inlinestaticinherited

get the min value for the unsigned integer type

Returns
the min value for the unsigned integer type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinULInt()

static tULInt CORE_Object::getMinULInt ( )
inlinestaticinherited

get the min value for tULInt type

Returns
the min value for tULInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinULLInt()

static tULLInt CORE_Object::getMinULLInt ( )
inlinestaticinherited

get the min value for tULLInt type

Returns
the min value for tULLInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getMinUSInt()

static tUSInt CORE_Object::getMinUSInt ( )
inlinestaticinherited

get the min value for tUSInt type

Returns
the min value for tUSInt type

Referenced by CORE_Test::testType().

Here is the caller graph for this function:

◆ getName()

virtual tString EMM_Operator::getName ( ) const
inlinevirtualinherited

return an human reading name of the operator

Returns
the name of the operator

References CORE_Object::getClassName(), EMM_Operator::isAffine(), EMM_Operator::isGradientComputationable(), tBoolean, tString, and tUIndex.

Here is the call graph for this function:

◆ getOut()

static SP::CORE_Out CORE_Object::getOut ( )
inlinestaticinherited

get the output

Returns
the shared pointer to the output stream

References CORE_Object::OUT.

◆ getPointerAddress()

tString CORE_Object::getPointerAddress ( ) const
inlineinherited

return the identity string of the object

Returns
the identity string of the object

References CORE_Object::pointer2String().

Here is the call graph for this function:

◆ getRealEpsilon()

static tReal CORE_Object::getRealEpsilon ( )
inlinestaticinherited

get the eps which is the difference between 1 and the least value greater than 1 that is representable.

Returns
the eps which is the difference between 1 and the least value greater than 1 that is representable.

Referenced by MATH_P4::solveP4De(), and CORE_Test::testType().

Here is the caller graph for this function:

◆ getRealInfinity()

static tReal CORE_Object::getRealInfinity ( )
inlinestaticinherited

◆ getSharedPointer() [1/2]

void CORE_Object::getSharedPointer ( SP::CORE_Object &  p)
inlineinherited

◆ getSharedPointer() [2/2]

void CORE_Object::getSharedPointer ( SPC::CORE_Object &  p) const
inlineinherited

get the shared pointer of this class into p

Parameters
p: shared pointer of the class This

◆ getThread()

static CORE_Thread& CORE_Object::getThread ( )
inlinestaticinherited

get the profilier

Returns
the profiler

Referenced by MATH_MaskVector::add(), MATH_Vector::add(), EMM_DisplacementFEMOperator::addBoundaryElasticStress(), EMM_DisplacementFEMOperator::buildDataOnNeumannBoundaryFaces(), EMM_DisplacementFVMOperator::computeCineticEnergy(), EMM_DisplacementFVMOperator::computeElasticStress(), EMM_DisplacementFEMOperator::computeElasticStress(), EMM_DisplacementFVMOperator::computeElasticTensor(), EMM_DisplacementFEMOperator::computeElasticTensor(), EMM_StaticMagneticTensorOperator::computeEnergy(), EMM_CubicAnisotropyOperator::computeEnergy(), EMM_MagnetostrictionOperator::computeEnergy(), EMM_DisplacementOperator::computeEnergy(), EMM_AnisotropyOperator::computeEnergyWithMagneticExcitation(), EMM_DisplacementFVMOperator::computeEquilibriumMatrixDiagonalConditioner(), EMM_DisplacementFEMOperator::computeEquilibriumMatrixDiagonalConditioner(), EMM_FullExchangeOperator::computeMagneticExcitationField(), EMM_StaticMagnetostrictionOperator::computeMagneticExcitationField(), EMM_LinearAnisotropyOperator::computeMagneticExcitationField(), EMM_StaticMagneticTensorOperator::computeMagneticExcitationField(), EMM_CubicAnisotropyOperator::computeMagneticExcitationField(), EMM_MinimalExchangeOperator::computeMagneticExcitationField(), EMM_AnisotropyOperator::computeMagneticExcitationField(), EMM_MagnetostrictionOperator::computeMagneticExcitationField(), EMM_CubicAnisotropyOperator::computeMagneticExcitationFieldGradient(), EMM_AnisotropyOperator::computeMagneticExcitationFieldGradient(), EMM_DisplacementFVMOperator::computeMagneticStress(), EMM_DisplacementFEMOperator::computeMagneticStress(), EMM_OptimalTimeStep::computeOptimalTimeStep(), EMM_DisplacementFEMOperator::computeStressConstraintEnergy(), EMM_FullExchangeOperator::discretize(), EMM_MinimalExchangeOperator::discretize(), EMM_CondensedMassMatrix::discretize(), EMM_LinearAnisotropyOperator::discretize(), EMM_AnisotropyOperator::discretize(), EMM_DemagnetizedOperator::discretize(), EMMG_SLDemagnetizedOperator::discretize(), EMM_LandauLifschitzSystem::discretize(), MATH_Vector::divide(), MATH_MaskVector::dot(), MATH_Vector::dot(), EMM_4SymmetricTensors::doubleDot(), EMM_4Tensors::doubleDotCrossDoubleDotScalar(), EMM_4Tensors::doubleDotCrossProduct(), EMM_4Tensors::doubleDotCrossSquaredScalar(), EMM_4Tensors::doubleDotProduct(), MATH_Vector::init(), MATH_MaskVector::init(), EMM_LandauLifschitzODE_RK::integrateMagnetizationFieldAtTime(), EMM_DisplacementFVM_Interpolator::interpolateUAtVertices(), EMMG_SLDemagnetizedOperator::localAssembly(), EMM_DisplacementOperator::nullProjectionOnDirichletBoundary(), EMM_DisplacementOperator::periodicProjection(), EMM_2PackedSymmetricTensors::product(), EMM_CanonicalMassMatrix::product(), MATH_FullMatrix::product(), EMM_CondensedMassMatrix::product(), EMM_BlockMassMatrix::product(), MATH_MorseMatrix::product(), EMMG_SLDemagnetizedOperator::product(), EMM_DisplacementOperator::projectionOnDirichletBoundary(), EMM_LandauLifschitzSystem::resetOperatorsToInitialState(), EMM_DisplacementFVMOperator::setBoundaryFaceTypes(), FFTW_MultiDFTs::setFFT(), FFTW_MultiLevelsDFT::setFFT(), FFTW_MultiLevelsDFT::setLevels(), FFTW_MultiDFTs::setPlan(), FFTW_MultiLevelsDFT::setPlan(), EMM_CondensedMassMatrix::solve(), EMM_LandauLifschitzODE::solveODE(), EMM_4SymmetricTensors::squaredDoubleDot(), EMM_4Tensors::squaredDoubleDotCrossScalar(), EMM_4Tensors::squaredDoubleDotScalar(), EMM_CanonicalMassMatrix::symmetricDot(), EMM_CondensedMassMatrix::symmetricDot(), EMM_BlockMassMatrix::symmetricDot(), FFTW_Test::test(), MATH_SolverTest::test(), EMM_ODETest::testODE(), and EMM_Grid3D::updateLimitConditionOnPoints().

Here is the caller graph for this function:

◆ getTypeName()

template<class T >
static tString CORE_Object::getTypeName ( )
inlinestaticinherited

get type name

Returns
the type name of the class

References tString.

◆ is32Architecture()

static tBoolean CORE_Object::is32Architecture ( )
inlinestaticinherited

return true if the machine is a 32 bits machine

Returns
true is the computing is done in a 32 bits machine

References CORE_Object::pointer2String(), CORE_Object::printObjectsInMemory(), and tString.

Referenced by CORE_Test::testType().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ is64Architecture()

static tBoolean CORE_Object::is64Architecture ( )
inlinestaticinherited

return true if the machine is a 64 bits machine

Returns
true is the computing is done in a 64 bits machine

Referenced by EMM_VTK::getVTKType(), and CORE_Test::testType().

Here is the caller graph for this function:

◆ isAffine()

virtual tBoolean EMM_MagneticExcitationLinearOperator::isAffine ( ) const
inlinevirtualinherited

return true if the operator is either constant or linear

Returns
true if the operator is either constant or linear

Implements EMM_Operator.

◆ isCubicVolume()

const tBoolean& EMM_Operator::isCubicVolume ( ) const
inlineinherited

return the true if the element is cubic

Returns
true is all size of the volum is same

References EMM_Operator::mIsCubic.

Referenced by EMM_FullExchangeOperator::discretize(), and EMM_MinimalExchangeOperator::discretize().

Here is the caller graph for this function:

◆ isGradientComputationable()

virtual tBoolean EMM_MagneticExcitationLinearOperator::isGradientComputationable ( ) const
inlinevirtualinherited

return true if the gradient of the magnetic excitation is computationable

Returns
true if the the gradient of the magnetic excitation is computationable

Implements EMM_Operator.

◆ isInstanceOf() [1/2]

template<class T >
tBoolean CORE_Object::isInstanceOf ( ) const
inlineinherited

test if the clas T is an instance of this class

Returns
true if the object is an instance of T

References null.

Referenced by MATH_ToeplitzTest::toeplitzTest().

Here is the caller graph for this function:

◆ isInstanceOf() [2/2]

tBoolean CORE_Object::isInstanceOf ( const tString name) const
inlineinherited

test if the object is an instance of className

Parameters
namename of the class
Returns
true if the object is an instance of class Name

References CORE_Object::getIdentityString().

Here is the call graph for this function:

◆ isMemoryChecked()

static const tBoolean& CORE_Object::isMemoryChecked ( )
inlinestaticinherited

get if the memory checking is used

Returns
true: if the memory checking is used.

References CORE_Object::getClassName(), CORE_Object::mIsMemoryTesting, and tString.

Referenced by main().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ New()

static SP::EMMG_UniaxialAnisotropyOperator EMMG_UniaxialAnisotropyOperator::New ( )
inlinestatic

create a uniaxial anisotropy operator

Returns
a shared pointer to a uniaxial anisotropy operator

References EMMG_UniaxialAnisotropyOperator().

Referenced by EMMG_ClassFactory::NewInstance().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ out()

static CORE_Out& CORE_Object::out ( )
inlinestaticinherited

get the output

Returns
the output stream

Referenced by EMM_Matter::adimensionize(), EMM_DisplacementFVMOperator::backup(), EMM_DisplacementOperator::backup(), MATH_ElementaryMultiLevelsToeplitzMatrix::buildSpectralVectorProjector(), EMM_Test::caseTest(), EMM_Test::caseTests(), EMM_MatterField::computeAnisotropyDirectionsField(), EMM_OptimalTimeStep::computeOptimalTimeStep(), MATH_MultiLevelsToeplitzMatrix::copy(), CORE_Exception::CORE_Exception(), EMM_MatterField::createAnisotropyOperator(), CORE_Run::createIO(), EMM_ElementaryTest::defaultBackupTest(), EMM_ElementaryTest::defaultTest(), MATH_MultiLevelsFFTToeplitzMatrix::diagonalize(), EMM_DisplacementFVMOperator::discretize(), EMM_MagnetostrictionOperator::discretize(), EMM_DisplacementFEMOperator::discretize(), EMM_4SymmetricTensors::doubleDot(), EMM_4Tensors::doubleDotCrossDoubleDotScalar(), EMM_TensorsTest::doubleDotCrossDoubleDotScalarTests(), EMM_4Tensors::doubleDotCrossProduct(), EMM_TensorsTest::doubleDotCrossProductTests(), EMM_4Tensors::doubleDotCrossSquaredScalar(), EMM_TensorsTest::doubleDotCrossSquaredScalarTests(), EMM_4Tensors::doubleDotProduct(), EMM_TensorsTest::doubleDotProductTests(), EMM_DisplacementWaveTest::elasticWaveTest(), EMM_Test::elementaryTests(), FFTW_Test::fftwTutorial(), MATH_IntegrationTest::gaussLegendreTest(), EMM_MagnetostrictionTest::HComputingTest(), EMM_DemagnetizedPeriodicalTest::HTest(), EMMH_HysteresisTest::hysteresisDefaultCycleTest(), EMM_TensorsTest::initializationTests(), EMM_MultiScaleGrid::initialize(), EMM_MultiScaleSDGrid::initialize(), EMM_MatterField::loadFromANIFile(), EMM_AnisotropyDirectionsField::loadFromFile(), EMM_Matter::loadFromFile(), EMM_Grid3D::loadFromGEOFile(), EMM_MatterField::loadFromLOCFile(), EMM_Array< tCellFlag >::loadFromStream(), EMM_Matter::loadFromStream(), EMM_Matter::loadMattersFromFile(), EMM_Run::loadSystemFromOptions(), EMM_ElementaryTest::magnetostrictionBackupTest(), CORE_Run::make(), EMMH_Run::makeHysteresis(), EMM_Run::makeRun(), CORE_Run::makeType(), EMM_ElementaryTest::optionsTest(), MATH_PolynomialTest::P4Tests(), EMM_Test::primaryTests(), EMM_LandauLifschitzSystem::printLog(), CORE_Run::printOptions(), EMM_2PackedSymmetricTensors::product(), EMMG_SLDemagnetizedOperator::projectionOnSpectralSpace(), CORE_Run::readOptionsFromCommandLine(), CORE_Test::readVectorTest(), EMM_DemagnetizedPeriodicalTest::relaxationTest(), EMM_DisplacementFVMOperator::restore(), EMM_DisplacementOperator::restore(), EMM_Input::restoreBackup(), EMMH_Hysteresis::run(), EMM_Output::save(), EMM_AnisotropyDirectionsField::saveToFile(), EMM_MatterField::saveToFile(), EMM_Grid3D::saveToGEOFile(), CORE_IOTest::searchTest(), EMMH_Hysteresis::setInitialMagnetizationField(), MATH_MultiLevelsToeplitzMatrix::setLevels(), EMM_4SymmetricTensors::squaredDoubleDot(), EMM_4Tensors::squaredDoubleDotCrossScalar(), EMM_TensorsTest::squaredDoubleDotCrossScalarTests(), EMM_4Tensors::squaredDoubleDotScalar(), EMM_TensorsTest::squaredDoubleDotScalarTests(), EMM_TensorsTest::squaredDoubleDotTests(), EMM_MatterTest::testAdimensionize(), EMM_MatterTest::testANIFile(), CORE_Test::testComplex(), CORE_Test::testDateWeek(), FFTW_Test::testDFT(), EMM_MatterTest::testIO(), EMM_ODETest::testODE(), CORE_Test::testOut(), CORE_Test::testReal(), EMM_FieldTest::testRealArray(), EMM_Grid3DTest::testSegment(), EMM_Grid3DTest::testThinSheet(), CORE_Test::testTime(), CORE_Test::testType(), MATH_FullMatrix::toString(), EMM_DemagnetizedPeriodicalTest::xyPeriodicalCubeSDGTest(), and EMM_DemagnetizedPeriodicalTest::xyPeriodicalSheetSDGTest().

Here is the caller graph for this function:

◆ pointer2String()

tString CORE_Object::pointer2String ( const void *  obj)
staticinherited

return the string representation of a pointer

Parameters
obj: oject to get the string pointer
Returns
the string pointer of the object

References tString.

Referenced by CORE_Object::CORE_Object(), CORE_Object::getIdentityString(), CORE_Object::getPointerAddress(), CORE_Object::is32Architecture(), and CORE_Object::~CORE_Object().

Here is the caller graph for this function:

◆ printObjectsInMemory() [1/2]

void CORE_Object::printObjectsInMemory ( ostream &  f)
staticinherited

print object in memory

Parameters
f: output to print the objects in memory

References CORE_Object::getIdentityString(), CORE_Object::getSharedPointer(), CORE_Object::mIsMemoryTesting, CORE_Object::mObjects, and tInteger.

Here is the call graph for this function:

◆ printObjectsInMemory() [2/2]

static void CORE_Object::printObjectsInMemory ( )
inlinestaticinherited

print object in memory in the standart output

Referenced by CORE_Object::is32Architecture(), and main().

Here is the caller graph for this function:

◆ resetOut()

static void CORE_Object::resetOut ( )
inlinestaticinherited

reset the output stream

Referenced by run().

Here is the caller graph for this function:

◆ resetThread()

static void CORE_Object::resetThread ( )
inlinestaticinherited

reset the output stream

Referenced by run().

Here is the caller graph for this function:

◆ resetToInitialState()

virtual tBoolean EMM_MagneticExcitationLinearOperator::resetToInitialState ( const EMM_LandauLifschitzSystem system)
inlinevirtualinherited

reset the data of the operator to its initial step t=0

Parameters
systemthe data to initialize the operator
Returns
true if it succeeds

do nothing : have no state

Implements EMM_Operator.

◆ restore()

virtual tBoolean EMM_Operator::restore ( const EMM_LandauLifschitzSystem system,
const tString prefix,
const tString suffix,
const tString ext 
)
inlinevirtualinherited

restore the operator data from file(s)

Parameters
system: general data to restore the operator
prefix: common prefix of the saving files
suffix: common suffix of the saving files
ext: common extension of the saving files
Returns
true: do nothing by default

Reimplemented in EMM_DisplacementOperator, EMM_MagnetostrictionOperator, and EMM_DisplacementFVMOperator.

References EMM_Operator::computeFieldsAtTime(), tBoolean, tFlag, tReal, and EMM_Operator::updateAtNextTimeStep().

Here is the call graph for this function:

◆ setIsMemoryChecked()

static void CORE_Object::setIsMemoryChecked ( const tBoolean v)
inlinestaticinherited

set if the memory checking is used

Parameters
v: true to check memory

Referenced by main().

Here is the caller graph for this function:

◆ setOut()

static void CORE_Object::setOut ( SP::CORE_Out  out)
inlinestaticinherited

set the output stream

Parameters
out: the shared pointer to the new output stream

References null.

◆ setThis()

void CORE_Object::setThis ( SP::CORE_Object  p)
inlineprotectedinherited

set this weak shared pointer called toDoAfterThis setting method

Parameters
p: shared pointer of the class This

References CORE_Object::toDoAfterThisSetting().

Here is the call graph for this function:

◆ setThread()

static void CORE_Object::setThread ( SP::CORE_Thread  thread)
inlinestaticinherited

set the thread

Parameters
threadthe shared pointer to the thread

References null.

Referenced by EMM_Run::EMM_Run(), EMM_TensorsRun::EMM_TensorsRun(), and MATH_SolverRun::MATH_SolverRun().

Here is the caller graph for this function:

◆ SP_OBJECT()

EMMG_UniaxialAnisotropyOperator::SP_OBJECT ( EMMG_UniaxialAnisotropyOperator  )
private

◆ toDoAfterThisSetting()

virtual void EMM_Object::toDoAfterThisSetting ( )
inlineprotectedvirtualinherited

method called after the setting of the shared pointer this method can only be called once.

Reimplemented from CORE_Object.

Reimplemented in EMM_DisplacementOperator, EMM_DisplacementFVMOperator, EMM_GaussLegendreRelaxation, and EMM_GradGaussLegendreRelaxation.

Referenced by EMM_GaussLegendreRelaxation::toDoAfterThisSetting(), and EMM_DisplacementOperator::toDoAfterThisSetting().

Here is the caller graph for this function:

◆ toString()

virtual tString CORE_Object::toString ( ) const
inlinevirtualinherited

return the string representation of the object node

Returns
the string representation of the object node

Reimplemented in EMM_DisplacementOperator, EMM_LandauLifschitzSystem, CORE_Array< T >, CORE_Array< tReal >, CORE_Array< tUInteger >, CORE_Array< tString >, CORE_Array< tLimitCondition >, CORE_Array< tUIndex >, CORE_Array< tUChar >, CORE_Array< tCellFlag >, EMM_Grid3D, CORE_Time, CORE_Vector< T >, EMM_Matter, CORE_Out, EMM_DisplacementFEMOperator, EMM_RealField, EMM_DisplacementFVMOperator, CORE_MorseArray< T >, CORE_MorseArray< tReal >, CORE_MorseArray< tUIndex >, CORE_MorseArray< tUChar >, EMM_MagnetostrictionOperator, MATH_MultiLevelsToeplitzMatrix, FFTW_ComplexArray, MATSGN_ComplexArray, EMM_MatterField, CORE_Color, FFTW_Complex, EMM_MultiScaleGrid, MATSGN_Complex, EMM_DisplacementFVM_VTEGROperator, EMM_CondensedMassMatrix, EMM_LandauLifschitzFunction, EMM_Tensors, EMM_DisplacementFVM_SSGROperator, EMMG_SLDemagnetizedOperator, EMM_BlockMassMatrix, CORE_Array2D< T >, EMM_DisplacementFVM_STEGROperator, EMMH_HysteresisFile, EMM_IterativeTimeStep, CORE_SharedPointersVMap< Key, Value >, CORE_SharedPointersVMap< tString, const CORE_Object >, CORE_SharedPointersVMap< tString, CORE_Object >, EMM_AnisotropyDirectionsField, EMM_DemagnetizedOperator, CORE_SharedPointersListVMap< Key, Value >, CORE_String, EMM_OptimalTimeStep, MATH_MaskArrayVector, CORE_SharedPointersKVMap< Key, Value >, MATH_ArrayVector, EMM_Stepper, EMM_CanonicalMassMatrix, MATH_Pn, MATH_FullMatrix, EMMG_SLPeriodicMultiScale, EMM_HyperElasticMatter, MATH_Matrix, CORE_Array3D< T >, EMM_CubicElasticMatter, CORE_Complex, CORE_Integer, CORE_Real, and EMM_MagnetostrictiveMatter.

References CORE_Object::getIdentityString().

Referenced by CORE_Out::genericPrint(), EMM_VelocitySolverTest::massMatrixTrivialSolverTest(), MATH_ConjugateGradient::solve(), CORE_SharedPointersKVMap< Key, Value >::toString(), CORE_SharedPointersListVMap< Key, Value >::toString(), CORE_SharedPointersVMap< tString, CORE_Object >::toString(), EMM_MagnetostrictionOperator::toString(), EMM_Matter::toString(), and EMM_DisplacementOperator::toString().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ updateAtNextTimeStep()

virtual tBoolean EMM_MagneticExcitationLinearOperator::updateAtNextTimeStep ( const tReal dt,
const EMM_RealArray sigma,
const EMM_RealField Mt 
)
inlinevirtualinherited

update the data of operator at next time step

Parameters
dtthe time step
sigmathe magnetized weight of each cell
Mtthe magnetization field at each point at next time step
Returns
true

Implements EMM_Operator.

Member Data Documentation

◆ Gamma

const tReal EMM_Object::Gamma =-1.7e11
staticinherited

◆ Mu0

const tReal EMM_Object::Mu0 =4*M_PI*1e-07
staticinherited

◆ NULL_VALUE

const tReal EMM_Object::NULL_VALUE ={0,0,0}
staticinherited

◆ X

const tDimension EMM_Object::X =0
staticinherited

◆ Y

const tDimension EMM_Object::Y =1
staticinherited

◆ Z

const tDimension EMM_Object::Z =2
staticinherited

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