OOFEM
2.4
OOFEM.org - Object Oriented Finite Element Solver
|
Implementation of matrix containing floating point numbers. More...
#include <floatmatrix.h>
Public Member Functions | |
FloatMatrix (int n, int m) | |
Creates matrix of given size. More... | |
FloatMatrix () | |
Creates zero sized matrix. More... | |
FloatMatrix (const FloatArray &vector, bool transpose=false) | |
Constructor. More... | |
FloatMatrix (const FloatMatrix &mat) | |
Copy constructor. More... | |
FloatMatrix (FloatMatrix &&mat) | |
Copy constructor. More... | |
FloatMatrix (std::initializer_list< std::initializer_list< double > >mat) | |
Initializer list constructor. More... | |
FloatMatrix & | operator= (std::initializer_list< std::initializer_list< double > >mat) |
Assignment operator. More... | |
FloatMatrix & | operator= (std::initializer_list< FloatArray >mat) |
Assignment operator. More... | |
FloatMatrix & | operator= (const FloatMatrix &mat) |
Assignment operator, adjusts size of the receiver if necessary. More... | |
FloatMatrix & | operator= (FloatMatrix &&mat) |
~FloatMatrix () | |
Destructor. More... | |
void | checkBounds (int i, int j) const |
Checks size of receiver towards requested bounds. More... | |
int | giveNumberOfRows () const |
Returns number of rows of receiver. More... | |
int | giveNumberOfColumns () const |
Returns number of columns of receiver. More... | |
bool | isSquare () const |
Returns nonzero if receiver is square matrix. More... | |
bool | isNotEmpty () const |
Tests for empty matrix. More... | |
bool | isFinite () const |
Returns true if no element is NAN or infinite. More... | |
double | at (int i, int j) const |
Coefficient access function. More... | |
double & | at (int i, int j) |
Coefficient access function. More... | |
double & | operator() (int i, int j) |
Coefficient access function. More... | |
double | operator() (int i, int j) const |
Coefficient access function. More... | |
void | assemble (const FloatMatrix &src, const IntArray &loc) |
Assembles the contribution using localization array into receiver. More... | |
void | assemble (const FloatMatrix &src, const IntArray &rowind, const IntArray &colind) |
Assembles the contribution using localization array into receiver. More... | |
void | assemble (const FloatMatrix &src, const int *rowind, const int *colind) |
Assembles the contribution using localization array into receiver. More... | |
double | computeFrobeniusNorm () const |
Computes the Frobenius norm of the receiver. More... | |
double | computeNorm (char p) const |
Computes the operator norm of the receiver. More... | |
double | computeReciprocalCondition (char p= '1') const |
Computes the conditioning of the receiver. More... | |
void | beDiagonal (const FloatArray &diag) |
Modifies receiver to be a diagonal matrix with the components specified in diag. More... | |
double | giveTrace () const |
Returns the trace of the receiver. More... | |
double | giveDeterminant () const |
Returns the trace (sum of diagonal components) of the receiver. More... | |
void | zero () |
Zeroes all coefficient of receiver. More... | |
void | beUnitMatrix () |
Sets receiver to unity matrix. More... | |
void | bePinvID () |
Sets receiver to the inverse of scaling matrix P multiplied by the deviatoric projector ID. More... | |
void | beTranspositionOf (const FloatMatrix &src) |
Assigns to the receiver the transposition of parameter. More... | |
void | beProductOf (const FloatMatrix &a, const FloatMatrix &b) |
Assigns to the receiver product of . More... | |
void | addProductOf (const FloatMatrix &a, const FloatMatrix &b) |
Adds to the receiver product of . More... | |
void | addTProductOf (const FloatMatrix &a, const FloatMatrix &b) |
Adds to the receiver product of . More... | |
void | beTProductOf (const FloatMatrix &a, const FloatMatrix &b) |
Assigns to the receiver product of . More... | |
void | beProductTOf (const FloatMatrix &a, const FloatMatrix &b) |
Assigns to the receiver product of . More... | |
void | beDyadicProductOf (const FloatArray &vec1, const FloatArray &vec2) |
Assigns to the receiver the dyadic product . More... | |
void | beNMatrixOf (const FloatArray &n, int nsd) |
Assigns the receiver to be a repeated diagonal matrix. More... | |
void | beLocalCoordSys (const FloatArray &normal) |
Makes receiver the local coordinate for the given normal. More... | |
void | setSubMatrix (const FloatMatrix &src, int sr, int sc) |
Adds the given matrix as sub-matrix to receiver. More... | |
void | setTSubMatrix (const FloatMatrix &src, int sr, int sc) |
Adds the given matrix as sub-matrix to receiver. More... | |
void | beSubMatrixOf (const FloatMatrix &src, int topRow, int bottomRow, int topCol, int bottomCol) |
Assigns to the receiver the sub-matrix of another matrix. More... | |
void | beSubMatrixOf (const FloatMatrix &src, const IntArray &indxRow, const IntArray &indxCol) |
Modifies receiver to be a sub-matrix of another matrix. More... | |
void | addSubVectorRow (const FloatArray &src, int sr, int sc) |
Adds given vector to receiver starting at given position. More... | |
void | addSubVectorCol (const FloatArray &src, int sr, int sc) |
Adds given vector to receiver starting at given position. More... | |
void | copySubVectorRow (const FloatArray &src, int sr, int sc) |
Copy (set) given vector to receiver row sr, starting at column sc. More... | |
void | setColumn (const FloatArray &src, int c) |
Sets the values of the matrix in specified column. More... | |
void | copyColumn (FloatArray &dest, int c) const |
Fetches the values from the specified column. More... | |
void | beInverseOf (const FloatMatrix &src) |
Modifies receiver to become inverse of given parameter. More... | |
bool | solveForRhs (const FloatArray &b, FloatArray &answer, bool transpose=false) |
Solves the system of linear equations . More... | |
void | solveForRhs (const FloatMatrix &B, FloatMatrix &answer, bool transpose=false) |
Solves the system of linear equations . More... | |
void | plusProductSymmUpper (const FloatMatrix &a, const FloatMatrix &b, double dV) |
Adds to the receiver the product . More... | |
void | plusDyadSymmUpper (const FloatArray &a, double dV) |
Adds to the receiver the dyadic product . More... | |
void | plusProductUnsym (const FloatMatrix &a, const FloatMatrix &b, double dV) |
Adds to the receiver the product . More... | |
void | plusDyadUnsym (const FloatArray &a, const FloatArray &b, double dV) |
Adds to the receiver the product . More... | |
void | add (const FloatMatrix &a) |
Adds matrix to the receiver. More... | |
void | add (double s, const FloatMatrix &a) |
Adds matrix to the receiver scaled by s. More... | |
void | subtract (const FloatMatrix &a) |
Subtracts matrix from the receiver. More... | |
void | times (double f) |
Multiplies receiver by factor f. More... | |
void | negated () |
Changes sign of receiver values. More... | |
void | initFromVector (const FloatArray &vector, bool transposed) |
Assigns to receiver one column or one row matrix containing vector. More... | |
void | symmetrized () |
Initializes the lower half of the receiver according to the upper half. More... | |
void | rotatedWith (const FloatMatrix &r, char mode= 'n') |
Returns the receiver 'a' transformed using give transformation matrix r. More... | |
void | resize (int rows, int cols) |
Checks size of receiver towards requested bounds. More... | |
void | resizeWithData (int, int) |
Checks size of receiver towards requested bounds. More... | |
void | hardResize (int r, int c) |
Resizing that enforces reallocation of memory. More... | |
void | clear () |
Sets size of receiver to be an empty matrix. It will have zero rows and zero columns size. More... | |
bool | jaco_ (FloatArray &eval, FloatMatrix &v, int nf) |
Computes eigenvalues and eigenvectors of receiver (must be symmetric) The receiver is preserved. More... | |
void | printYourself () const |
Prints matrix to stdout. Useful for debugging. More... | |
void | printYourself (const std::string &name) const |
Print receiver on stdout with custom name. More... | |
void | printYourselfToFile (const std::string filename, const bool showDimensions=true) const |
Print matrix to file. More... | |
void | pY () const |
Higher accuracy than printYourself. More... | |
void | writeCSV (const std::string &name) const |
Writes receiver as CSV (comma seperated values) More... | |
const double * | givePointer () const |
Exposes the internal values of the matrix. More... | |
double * | givePointer () |
void | beMatrixFormOfStress (const FloatArray &aArray) |
Reciever will be a 3x3 matrix formed from a vector with either 9 or 6 components. More... | |
void | beMatrixForm (const FloatArray &aArray) |
void | changeComponentOrder () |
Swaps the indices in the 6x6 matrix such that it converts between OOFEM's and Abaqus' way of writing matrices. More... | |
contextIOResultType | storeYourself (DataStream &stream) const |
contextIOResultType | restoreYourself (DataStream &stream) |
int | givePackSize (DataStream &buff) const |
Protected Attributes | |
int | nRows |
Number of rows. More... | |
int | nColumns |
Number of columns. More... | |
std::vector< double > | values |
Values of matrix stored column wise. More... | |
Friends | |
std::ostream & | operator<< (std::ostream &out, const FloatMatrix &r) |
Implementation of matrix containing floating point numbers.
FloatMatrix can grow and shrink to requested size if required. Implementation includes many computing and manipulation methods. Rows and Columns are indexed starting from 1.
The matrix stores its nRows*nColumns coefficients in 'values'. The coefficients are stored column by column, like in Fortran.
Tasks:
Definition at line 94 of file floatmatrix.h.
|
inline |
Creates matrix of given size.
n | Number of rows. |
m | Requested number of columns. |
Definition at line 110 of file floatmatrix.h.
|
inline |
Creates zero sized matrix.
Definition at line 112 of file floatmatrix.h.
oofem::FloatMatrix::FloatMatrix | ( | const FloatArray & | vector, |
bool | transpose = false |
||
) |
Constructor.
Creates float matrix from float vector. Vector may be stored row wise or column wise, depending on second parameter.
vector | Float vector from which matrix is constructed |
transpose | If false (default) then a matrix of size (vector->giveSize(),1) will be created and initialized, if true then a matrix of size (1,vector->giveSize()) will be created. |
Definition at line 113 of file floatmatrix.C.
References oofem::FloatArray::giveSize(), nColumns, nRows, oofem::FloatArray::values, and values.
|
inline |
Copy constructor.
Definition at line 123 of file floatmatrix.h.
|
inline |
Copy constructor.
Definition at line 125 of file floatmatrix.h.
oofem::FloatMatrix::FloatMatrix | ( | std::initializer_list< std::initializer_list< double > > | mat | ) |
Initializer list constructor.
Definition at line 131 of file floatmatrix.C.
References nRows, OOFEM_ERROR, RESIZE, and values.
|
inline |
Destructor.
Definition at line 146 of file floatmatrix.h.
void oofem::FloatMatrix::add | ( | const FloatMatrix & | a | ) |
Adds matrix to the receiver.
If receiver has zero size, size is accordingly adjusted.
a | Matrix to be added. |
Definition at line 1023 of file floatmatrix.C.
References givePointer(), isNotEmpty(), nColumns, nRows, OOFEM_ERROR, operator=(), and values.
Referenced by oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::TR1_2D_SUPG_AXI::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCLhsTerm_MB(), oofem::SUPGElement::computeBCLhsTerm_MB(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::ConcreteDPM::computeDDRhoDDStress(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::HTSelement::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::TrPlanestressRotAllman::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::Shell7Base::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::Shell7BaseXFEM::evalCovarBaseVectorsAt(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::TutorialMaterial::give3dMaterialStiffnessMatrix(), oofem::MisesMatGrad::give3dMaterialStiffnessMatrix(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::MisesMat::give3dMaterialStiffnessMatrix(), oofem::TrabBoneNL3D::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::LargeStrainMasterMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::TwoFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::GradDpElement::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::PerfectlyPlasticMaterial::giveMaterialStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::IsotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FCMMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::Shell7Base::giveRecoveredTransverseInterfaceStress(), oofem::LayeredCrossSection::giveStiffnessMatrix_PlaneStress(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::TR21_2D_SUPG::LS_PCS_computedN(), oofem::MidpointLhsAssembler::matrixFromElement(), oofem::EffectiveTangentAssembler::matrixFromElement(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha2(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::Shell7BaseXFEM::recoverShearStress(), and oofem::Shell7Base::recoverShearStress().
void oofem::FloatMatrix::add | ( | double | s, |
const FloatMatrix & | a | ||
) |
Adds matrix to the receiver scaled by s.
If receiver has zero size, size is accordingly adjusted.
s | Scaling factor. |
a | Matrix to be added. |
Definition at line 1054 of file floatmatrix.C.
References givePointer(), isNotEmpty(), nColumns, nRows, OOFEM_ERROR, operator=(), times(), and values.
void oofem::FloatMatrix::addProductOf | ( | const FloatMatrix & | a, |
const FloatMatrix & | b | ||
) |
Adds to the receiver product of .
Definition at line 427 of file floatmatrix.C.
References at(), givePointer(), nColumns, nRows, and OOFEM_ERROR.
Referenced by oofem::Shell7BaseXFEM::discComputeStiffness().
void oofem::FloatMatrix::addSubVectorCol | ( | const FloatArray & | src, |
int | sr, | ||
int | sc | ||
) |
Adds given vector to receiver starting at given position.
src | Source matrix. |
sr | Starting row position. |
sc | Starting column position. |
Definition at line 627 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::FloatArray::giveSize(), oofem::max(), and resizeWithData().
Referenced by oofem::Node2NodeContactL::computeContactTangent(), oofem::ContactElement::ContactElement(), and oofem::Shell7Base::giveTractionBC().
void oofem::FloatMatrix::addSubVectorRow | ( | const FloatArray & | src, |
int | sr, | ||
int | sc | ||
) |
Adds given vector to receiver starting at given position.
src | Source matrix. |
sr | Starting row position. |
sc | Starting column position. |
Definition at line 607 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::FloatArray::giveSize(), oofem::max(), and resizeWithData().
Referenced by oofem::Node2NodeContactL::computeContactTangent(), oofem::ContactElement::ContactElement(), oofem::Shell7Base::giveL2contribution(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Shell7Base::giveSPRcontribution(), and oofem::Shell7Base::nodalLeastSquareFitFromIP().
void oofem::FloatMatrix::addTProductOf | ( | const FloatMatrix & | a, |
const FloatMatrix & | b | ||
) |
Adds to the receiver product of .
Definition at line 459 of file floatmatrix.C.
References at(), givePointer(), nColumns, nRows, and OOFEM_ERROR.
void oofem::FloatMatrix::assemble | ( | const FloatMatrix & | src, |
const IntArray & | loc | ||
) |
Assembles the contribution using localization array into receiver.
The receiver must have dimensions large enough to localize contribution.
src | Source to be assembled. |
loc | Localization indices. |
Definition at line 251 of file floatmatrix.C.
References oofem::IntArray::at(), at(), giveNumberOfRows(), oofem::IntArray::giveSize(), isSquare(), and OOFEM_ERROR.
Referenced by oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::SolidShell::computeGeometricStiffness(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::Shell7Base::computeMassMatrixNum(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::GradDpElement::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::MITC4Shell::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientDirichlet::computeXi(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::SUPGElement2::giveCharacteristicMatrix(), oofem::PFEMElement::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TR_SHELL02::giveCharacteristicMatrix(), oofem::TR_SHELL01::giveCharacteristicMatrix(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::StructuralMaterial::giveFullSymMatrixForm(), oofem::GradDpElement::giveInternalForcesVector(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::SUPGTangentAssembler::matrixFromElement(), and oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix().
void oofem::FloatMatrix::assemble | ( | const FloatMatrix & | src, |
const IntArray & | rowind, | ||
const IntArray & | colind | ||
) |
Assembles the contribution using localization array into receiver.
The receiver must have dimensions large enough to localize contribution.
src | Source to be assembled. |
rowind | Row localization indices. |
colind | Column localization indices. |
Definition at line 277 of file floatmatrix.C.
References oofem::IntArray::at(), at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::IntArray::giveSize(), and OOFEM_ERROR.
void oofem::FloatMatrix::assemble | ( | const FloatMatrix & | src, |
const int * | rowind, | ||
const int * | colind | ||
) |
Assembles the contribution using localization array into receiver.
The receiver must have dimensions large enough to localize contribution.
src | Source to be assembled. |
rowind | Row localization indices. |
colind | Column localization indices. |
Definition at line 305 of file floatmatrix.C.
References at(), giveNumberOfColumns(), and giveNumberOfRows().
|
inline |
Coefficient access function.
Returns value of coefficient at given position of the receiver. Implements 1-based indexing.
i | Row position of coefficient. |
j | Column position of coefficient. |
Definition at line 176 of file floatmatrix.h.
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), addProductOf(), addSubVectorCol(), addSubVectorRow(), addTProductOf(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::SymmetryBarrier::applyConstraint(), oofem::MDM::applyDamageToStiffness(), oofem::SpoolesSparseMtrx::assemble(), oofem::SkylineUnsym::assemble(), oofem::DynCompRow::assemble(), oofem::DynCompCol::assemble(), oofem::LinearConstraintBC::assemble(), oofem::Skyline::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), assemble(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::PrescribedGradientBCWeak::assembleExtraDisplock(), oofem::TransportElement::assembleLocalContribution(), oofem::Beam3d::B3SSMI_getUnknownsGtoLRotationMatrix(), beDyadicProductOf(), beInverseOf(), beLocalCoordSys(), beMatrixForm(), beMatrixFormOfStress(), oofem::FloatArray::beProductOf(), beProductOf(), beProductTOf(), beSubMatrixOf(), oofem::FloatArray::beSymVectorForm(), oofem::FloatArray::beSymVectorFormOfStrain(), oofem::FloatArray::beTProductOf(), beTProductOf(), beTranspositionOf(), beUnitMatrix(), oofem::FloatArray::beVectorForm(), oofem::Grid::calcTime(), changeComponentOrder(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::ParticleTopologyDescription::checkOverlap(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::AnisotropicDamageMaterial::checkSymmetry(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::Tr2Shell7::compareMatrices(), oofem::ConcreteDPM2::compute1dJacobian(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MC(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue2D(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::Quad1PlaneStrain::computeBHmatrixAt(), oofem::PlaneStress2d::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::Tet1_3D_SUPG::computeBMatrix(), oofem::PFEMElement2d::computeBMatrix(), oofem::TR21_2D_SUPG::computeBMatrix(), oofem::Quad10_2D_SUPG::computeBMatrix(), oofem::LSpaceBB::computeBmatrixAt(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBmatrixAt(), oofem::TrPlanestressRotAllman::computeBmatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::Tr_Warp::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::CCTPlate::computeBmatrixAt(), oofem::QDKTPlate::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElem2dQuad::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::DKTPlate::computeBmatrixAt(), oofem::LIBeam2d::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::PlaneStress2d::computeBmatrixAt(), oofem::LIBeam2dNL::computeBmatrixAt(), oofem::LIBeam3d::computeBmatrixAt(), oofem::Truss3d::computeBmatrixAt(), oofem::tet21ghostsolid::computeBmatrixAt(), oofem::Truss2d::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::MITC4Shell::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::TR1_2D_SUPG_AXI::computeBMtrx(), oofem::TR1_2D_SUPG2_AXI::computeBMtrx(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::Lattice2d_mt::computeCapacityMatrix(), oofem::FreeWarping::computeCenterOfGravity(), oofem::KelvinChainMaterial::computeCharCoefficients(), oofem::MaxwellChainMaterial::computeCharCoefficients(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Lattice2d_mt::computeConductivityMatrix(), oofem::Beam2d::computeConsistentMassMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::TR1_2D_CBS::computeConsistentMassMtrx(), oofem::PlasticMaterial::computeConsistentModuli(), oofem::Node2NodeContactL::computeContactTangent(), oofem::AnisotropicDamageMaterial::computeCorrectionFactor(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::IntElLine1IntPen::computeCovarBaseVectorAt(), oofem::IntElLine2IntPen::computeCovarBaseVectorAt(), oofem::IntElLine1PF::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorAt(), oofem::IntElLine1::computeCovarBaseVectorAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::IntElLine1PhF::computeCovarBaseVectorsAt(), oofem::FRCFCM::computeCrackFibreAngle(), oofem::AnisotropicDamageMaterial::computeDamage(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::MDM::computeDamageTensor(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::PlasticMaterial::computeDiagModuli(), oofem::MPlasticMaterial::computeDiagModuli(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::AnisotropicDamageMaterial::computeDimensionlessOutOfPlaneStress(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::TR21_2D_SUPG::computeDivTauMatrix(), oofem::Tet1_3D_SUPG::computeDivUMatrix(), oofem::TR21_2D_SUPG::computeDivUMatrix(), oofem::Quad10_2D_SUPG::computeDivUMatrix(), oofem::Element::computeDofTransformationMatrix(), oofem::SolidShell::computeEASBmatrixAt(), oofem::DKTPlate::computeEdgeNMatrix(), oofem::TrPlanestressRotAllman::computeEgdeNMatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::SolidShell::computeEVector(), oofem::SolidShell::computeGeometricStiffness(), oofem::MITC4Shell::computeGlobalCoordinates(), oofem::IntElLine1PF::computeGMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Lattice2d_mt::computeGradientMatrixAt(), oofem::Tet1_3D_SUPG::computeGradUMatrix(), oofem::TR21_2D_SUPG::computeGradUMatrix(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::LIBeam2dNL::computeGtoLRotationMatrix(), oofem::LIBeam2d::computeGtoLRotationMatrix(), oofem::LIBeam3d::computeGtoLRotationMatrix(), oofem::LIBeam3d2::computeGtoLRotationMatrix(), oofem::RerShell::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::InterfaceElem2dLin::computeGtoLRotationMatrix(), oofem::InterfaceElem2dQuad::computeGtoLRotationMatrix(), oofem::InterfaceElement3dTrLin::computeGtoLRotationMatrix(), oofem::TrPlanestressRotAllman3d::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::Lattice2d::computeGtoLRotationMatrix(), oofem::SpringElement::computeGtoLRotationMatrix(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::Beam2d::computeGtoLRotationMatrix(), oofem::Beam3d::computeGtoLRotationMatrix(), oofem::J2MPlasticMaterial::computeHardeningReducedModuli(), oofem::J2plasticMaterial::computeHardeningReducedModuli(), oofem::TR1_2D_SUPG::computeHomogenizedReinforceTerm_MB(), oofem::TR1_2D_SUPG::computeHomogenizedReinforceTerm_MC(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::NLStructuralElement::computeInitialStressMatrix(), oofem::AnisotropicDamageMaterial::computeInplaneStress(), oofem::ConcreteDPM2::computeJacobian(), oofem::Beam3d::computeKappaCoeffs(), oofem::Node::computeL2GTransformation(), oofem::Shell7Base::computeLambdaGMatrices(), oofem::Shell7BaseXFEM::computeLambdaGMatricesDis(), oofem::Shell7Base::computeLambdaNMatrix(), oofem::Shell7BaseXFEM::computeLambdaNMatrixDis(), oofem::InterfaceElement3dTrLin::computeLCS(), oofem::Quad1MindlinShell3D::computeLCS(), oofem::TR1_2D_SUPG_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeLinearAdvectionTerm_MC(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::TrPlaneStrRot3d::computeLoadGToLRotationMtrx(), oofem::TrPlanestressRotAllman3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadGToLRotationMtrx(), oofem::LinQuad3DPlaneStress::computeLoadGToLRotationMtrx(), oofem::CCTPlate3d::computeLoadGToLRotationMtrx(), oofem::LIBeam2d::computeLoadGToLRotationMtrx(), oofem::LIBeam2dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d::computeLoadGToLRotationMtrx(), oofem::MITC4Shell::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL2::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d2::computeLoadGToLRotationMtrx(), oofem::Beam3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadLEToLRotationMatrix(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::CCTPlate::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::Quad1Mindlin::computeLoadLEToLRotationMatrix(), oofem::Truss2d::computeLoadLEToLRotationMatrix(), oofem::DKTPlate::computeLoadLEToLRotationMatrix(), oofem::QDKTPlate::computeLoadLEToLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLoadLEToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::tet21ghostsolid::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::MDM::computeLocalDamageTensor(), oofem::TR1_2D_SUPG_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2::computeLSICStabilizationTerm_MB(), oofem::MITC4Shell::computeLToDirectorRotationMatrix(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::LIBeam2dNL::computeLumpedMassMatrix(), oofem::LIBeam2d::computeLumpedMassMatrix(), oofem::LIBeam3d::computeLumpedMassMatrix(), oofem::Truss3d::computeLumpedMassMatrix(), oofem::Truss1d::computeLumpedMassMatrix(), oofem::LTRSpace::computeLumpedMassMatrix(), oofem::RerShell::computeLumpedMassMatrix(), oofem::Truss2d::computeLumpedMassMatrix(), oofem::LIBeam3dNL::computeLumpedMassMatrix(), oofem::LIBeam3dNL2::computeLumpedMassMatrix(), oofem::LIBeam3d2::computeLumpedMassMatrix(), oofem::SpringElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::Quad1Mindlin::computeLumpedMassMatrix(), oofem::CCTPlate::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::DKTPlate::computeLumpedMassMatrix(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::RigidArmNode::computeMasterContribution(), oofem::StrainVector::computeMaxPrincipalDir(), oofem::LIBeam2dNL::computeNLBMatrixAt(), oofem::TrPlaneStrRot::computeNmatrixAt(), oofem::TrPlanestressRotAllman::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::CCTPlate::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::LIBeam2d::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::LIBeam2dNL::computeNmatrixAt(), oofem::LIBeam3d::computeNmatrixAt(), oofem::Truss2d::computeNmatrixAt(), oofem::Truss1d::computeNmatrixAt(), oofem::MITC4Shell::computeNmatrixAt(), oofem::IntElPoint::computeNmatrixAt(), oofem::LIBeam3dNL2::computeNmatrixAt(), oofem::LIBeam3dNL::computeNmatrixAt(), oofem::RerShell::computeNmatrixAt(), oofem::LIBeam3d2::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), computeNorm(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::Lattice2d_mt::computeNSubMatrixAt(), oofem::WeakPeriodicBoundaryCondition::computeOrthogonalBasis(), oofem::TR1_2D_SUPG::computeOutFlowBCTerm_MB(), oofem::AnisotropicDamageMaterial::computeOutOfPlaneStrain(), oofem::HTSelement::computeOutwardNormalMatrix(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::TR1_2D_SUPG::computePenetrationWithResistanceBCTerm_MB(), oofem::AnisotropicDamageMaterial::computePlaneStressSigmaZ(), oofem::AnisotropicDamageMaterial::computePlaneStressStrain(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::TR1_2D_CBS::computePressureLhs(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG::computePressureTerm_MB(), oofem::TR1_2D_SUPG2::computePressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG::computePressureTerm_MC(), oofem::TR1_2D_SUPG2::computePressureTerm_MC(), oofem::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::WeakPeriodicBoundaryCondition::computeProjectionCoefficient(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), oofem::LIBeam3dNL2::computeQuaternionFromRotMtrx(), oofem::Masonry02::computeReducedElasticModuli(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::Masonry02::computeReducedSKGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::Masonry02::computeReducedSSGradientMatrix(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrxFromQuaternion(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::DKTPlate::computeShearForces(), oofem::TR1_2D_SUPG::computeSlipWithFrictionBCTerm_MB(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::SpringElement::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::MITC4Shell::computeStiffnessMatrix(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::TrPlanestressRotAllman::computeStiffnessMatrixZeroEnergyStabilization(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::RankinePlasticMaterial::computeStressGradientVector(), oofem::DruckerPragerCutMat::computeStressGradientVector(), oofem::MITC4Shell::computeSurfaceVolumeAround(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::AnisotropicDamageMaterial::computeTraceD(), oofem::StructuralInterfaceElement::computeTraction(), oofem::Line::computeTransformationMatrix(), oofem::IntElLine1PF::computeTransformationMatrixAt(), oofem::IntElLine1PhF::computeTransformationMatrixAt(), oofem::IntElLine1::computeTransformationMatrixAt(), oofem::IntElPoint::computeTransformationMatrixAt(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::GravityPressure::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::LIBeam3dNL::computeXMtrx(), oofem::LIBeam3dNL2::computeXMtrx(), oofem::StructuralElement::condense(), oofem::TrabBone3D::constructAnisoComplTensor(), oofem::TrabBone3D::constructAnisoFabricTensor(), oofem::TrabBone3D::constructAnisoStiffnessTensor(), oofem::TrabBone3D::constructFabricTransformationMatrix(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), oofem::TrabBoneEmbed::constructIsoComplTensor(), oofem::LargeStrainMasterMaterial::constructL1L2TransformationMatrices(), oofem::TrabBone3D::constructNormAdjustTensor(), oofem::TrabBone3D::constructStiffnessTransformationMatrix(), oofem::LargeStrainMasterMaterial::constructTransformationMatrix(), oofem::ContactElement::ContactElement(), oofem::StructuralMaterial::convert_dSdE_2_dPdF(), copySubVectorRow(), oofem::AnisotropicDamageMaterial::correctBigValues(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::LEPlic::doCellDLS(), oofem::CrackExportModule::doOutput(), oofem::LIBeam3dNL2::drawDeformedGeometry(), oofem::LIBeam3d2::drawDeformedGeometry(), oofem::CohesiveSurface3d::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::LSpace::drawTriad(), oofem::Node::drawYourself(), oofem::DarcyFlow::DumpMatricesToFile(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7Base::edgeComputeNmatrixAt(), oofem::FEI3dHexaLin::edgeEvaldNdx(), oofem::FEI3dTetLin::edgeEvaldNdx(), oofem::FEI3dLineLin::edgeEvaldNdx(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::FEI2dTrQuad::evald2Ndx2(), oofem::FEI1dHermite::evald2Ndx2(), oofem::FEI2dQuadConst::evaldNdx(), oofem::FEI3dTetLin::evaldNdx(), oofem::FEI2dTrLin::evaldNdx(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI2dQuadLin::evaldNdx(), oofem::FEI3dLineLin::evaldNdx(), oofem::FEI1dHermite::evaldNdx(), oofem::FEI1dLin::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI2dLineQuad::evaldNdxi(), oofem::FEI2dTrQuad::evaldNdxi(), oofem::FEI2dQuadLin::evaldNdxi(), oofem::FEI2dQuadQuad::evaldNdxi(), oofem::Shell7Base::evalInitialCovarBaseVectorsAt(), oofem::PrescribedGenStrainShell7::evaluateHigherOrderContribution(), oofem::CohesiveSurface3d::evaluateLocalCoordinateSystem(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::RankineMat::evaluatePlaneStressStiffMtrx(), oofem::VTKExportModule::exportCellVars(), oofem::VTKExportModule::exportIntVarAs(), oofem::Grid::fastMarch(), oofem::FCMMaterialStatus::FCMMaterialStatus(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::MDM::formTransformationMatrix(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase2D(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase3D(), oofem::RotatingBoundary::give(), oofem::IDGMaterial::give1dGprime(), oofem::MisesMatGrad::give1dGprime(), oofem::IDGMaterial::give1dKappaMatrix(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_dTdj(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng(), oofem::CebFipSlip90Material::give1dStiffnessMatrix_Eng(), oofem::IDGMaterial::give1dStressStiffMtrx(), oofem::MisesMatGrad::give1dStressStiffMtrx(), oofem::MisesMat::give1dStressStiffMtrx(), oofem::MisesMatNl::give1dStressStiffMtrx(), oofem::TrabBoneMaterial::give1dStressStiffMtrx(), oofem::SteelRelaxMat::give1dStressStiffMtrx(), oofem::IsotropicLinearElasticMaterial::give1dStressStiffMtrx(), oofem::RankineMat::give1dStressStiffMtrx(), oofem::StructuralMaterial::give1dStressStiffMtrx(), oofem::ConcreteDPM2::give1dStressStiffMtrx(), oofem::StructuralMaterial::give2dBeamLayerStiffMtrx(), oofem::SimpleCrossSection::give2dBeamStiffMtrx(), oofem::LayeredCrossSection::give2dBeamStiffMtrx(), oofem::SimpleCrossSection::give2dPlateStiffMtrx(), oofem::LayeredCrossSection::give2dPlateStiffMtrx(), oofem::WinklerPasternakMaterial::give2dPlateSubSoilStiffMtrx(), oofem::WinklerMaterial::give2dPlateSubSoilStiffMtrx(), oofem::IntMatIsoDamage::give2dStiffnessMatrix_Eng(), oofem::StructuralMaterial::give2DStrainVectorTranformationMtrx(), oofem::SimpleCrossSection::give3dBeamStiffMtrx(), oofem::FiberedCrossSection::give3dBeamStiffMtrx(), oofem::SimpleCrossSection::give3dDegeneratedShellStiffMtrx(), oofem::LargeStrainMasterMaterialGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::MisesMatGrad::give3dGprime(), oofem::LargeStrainMasterMaterialGrad::give3dKappaMatrix(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::OrthotropicLinearElasticMaterial::give3dLocalMaterialStiffnessMatrix(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::HyperElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::SimpleVitrificationMaterial::give3dMaterialStiffnessMatrix(), oofem::M1Material::give3dMaterialStiffnessMatrix(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::IsotropicLinearElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::MicroplaneMaterial::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::AnisotropicDamageMaterial::give3dMaterialStiffnessMatrix(), oofem::MooneyRivlinMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::LargeStrainMasterMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::SimpleCrossSection::give3dShellStiffMtrx(), oofem::LayeredCrossSection::give3dShellStiffMtrx(), oofem::IntMatBilinearCZElastic::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::CohesiveInterfaceMaterial::give3dStiffnessMatrix_Eng(), oofem::IntMatPhaseField::give3dStiffnessMatrix_Eng(), oofem::SimpleInterfaceMaterial::give3dStiffnessMatrix_Eng(), oofem::ExpCZMaterial::give3dStiffnessMatrix_Eng(), oofem::BondCEBMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial_2::give3dStiffnessMatrix_Eng(), oofem::IntMatIsoDamage::give3dStiffnessMatrix_Eng(), oofem::Shell7Base::giveAxialMatrix(), oofem::IsotropicMoistureTransferMaterial::giveCharacteristicMatrix(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::IsotropicHeatTransferMaterial::giveCharacteristicMatrix(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::MITC4Shell::giveCharacteristicTensor(), oofem::CompoDamageMat::giveCharLength(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::RCM2Material::giveCrackedStiffnessMatrix(), oofem::FEI2dQuadBiQuad::giveDerivatives(), oofem::TutorialMaterial::giveDeviatoricProjectionMatrix(), oofem::NewtonianFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::BinghamFluidMaterial2::giveDeviatoricStiffnessMatrix(), oofem::MITC4Shell::giveDirectorVectors(), oofem::MITC4Shell::givedNdx(), oofem::IntElSurfTr1::giveDofManDofIDMask(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::FE2FluidMaterial::giveEffectiveViscosity(), oofem::LatticeDamage2d::giveElasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::StructuralMaterial::giveFiberStiffMtrx(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::StructuralPythonMaterial::giveFirstPKStressVector_3d(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::StructuralMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::StructuralInterfaceMaterial::giveFirstPKTraction_1d(), oofem::StructuralInterfaceMaterial::giveFirstPKTraction_2d(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::PrescribedGradientHomogenization::giveGradientVoigt(), oofem::AnisotropicLinearElasticMaterial::giveInputRecord(), oofem::Element::giveInputRecord(), oofem::GradDpElement::giveInternalForcesVector(), oofem::LIBeam3dNL2::giveInternalForcesVector(), oofem::LIBeam3dNL::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IDGMaterial::giveInternalLength(), oofem::TrabBoneGrad3D::giveInternalLength(), oofem::RankineMatGrad::giveInternalLength(), oofem::MisesMatGrad::giveInternalLength(), oofem::IDGMaterial::giveInternalLengthDerivative(), oofem::TrPlaneStrRot3d::giveIPValue(), oofem::tet21ghostsolid::giveIPValue(), oofem::CCTPlate3d::giveIPValue(), oofem::LinQuad3DPlaneStress::giveIPValue(), oofem::TrPlanestressRotAllman3d::giveIPValue(), oofem::RerShell::giveIPValue(), oofem::DKTPlate3d::giveIPValue(), oofem::RVEStokesFlow::giveIPValue(), oofem::MITC4Shell::giveIPValue(), oofem::RCM2Material::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::MDM::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::MITC4Shell::giveJacobian(), oofem::FEInterpolation2d::giveJacobianMatrixAt(), oofem::FEI3dLineLin::giveJacobianMatrixAt(), oofem::Beam2d::giveKappaCoeff(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Lattice2d::giveLocalCoordinateSystem(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::Truss2d::giveLocalCoordinateSystem(), oofem::Beam2d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::FCMMaterial::giveLocalCrackedStiffnessMatrix(), oofem::FEI3dHexaTriQuad::giveLocalDerivative(), oofem::FEI3dHexaLin::giveLocalDerivative(), oofem::FEI3dWedgeQuad::giveLocalDerivative(), oofem::FEI3dWedgeLin::giveLocalDerivative(), oofem::FEI3dHexaQuad::giveLocalDerivative(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::FEI3dTrQuad::giveLocalNodeCoords(), oofem::FEI3dWedgeQuad::giveLocalNodeCoords(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::Structural2DElement::giveMaterialOrientationAt(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::SimpleCrossSection::giveMembraneRotStiffMtrx(), oofem::MazarsMaterial::giveNormalBlockOfElasticCompliance(), oofem::IDNLMaterial::giveNormalElasticStiffnessMatrix(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), oofem::IDGMaterial::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::IDGMaterial::givePlaneStrainKappaMatrix(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::IsotropicLinearElasticMaterial::givePlaneStrainStiffMtrx(), oofem::StructuralMaterial::givePlaneStrainStiffMtrx(), oofem::MooneyRivlinMaterial::givePlaneStrainStiffMtrx_dPdF(), oofem::IDGMaterial::givePlaneStressGprime(), oofem::RankineMatGrad::givePlaneStressGprime(), oofem::IDGMaterial::givePlaneStressKappaMatrix(), oofem::RankineMatGrad::givePlaneStressKappaMatrix(), oofem::IsotropicLinearElasticMaterial::givePlaneStressStiffMtrx(), oofem::AnisotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::StructuralMaterial::givePlaneStressStiffMtrx(), oofem::StructuralMaterial::givePlaneStressVectorTranformationMtrx(), oofem::StructuralMaterial::givePlateLayerStiffMtrx(), oofem::MDM::giveRawMDMParameters(), oofem::FRCFCMNL::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::HyperElasticMaterial::giveRealStressVector_3d(), oofem::LinearElasticMaterial::giveRealStressVector_3dDegeneratedShell(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::DruckerPragerPlasticitySM::giveRegAlgorithmicStiffMatrix(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::TR_SHELL02::giveRotationMatrix(), oofem::TR_SHELL01::giveRotationMatrix(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::LatticeDamage2d::giveSecantStiffnessMatrix(), oofem::Grid::giveSolutionValueAt(), oofem::StructuralMaterial::giveStrainVectorTranformationMtrx(), oofem::StructuralMaterial::giveStressVectorTranformationMtrx(), oofem::IntMatPhaseField::giveTangents(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::StrainVector::giveTranformationMtrx(), oofem::StressVector::giveTranformationMtrx(), oofem::EigenValueDynamic::giveUnknownComponent(), oofem::LinearStability::giveUnknownComponent(), oofem::CompoDamageMat::giveUnrotated3dMaterialStiffnessMatrix(), oofem::Node::giveUpdatedCoordinate(), oofem::DruckerPragerPlasticitySM::giveVertexAlgorithmicStiffMatrix(), oofem::Shell7Base::giveZ2integratedPolynomial2GradientForStressRecAt(), oofem::FEI3dHexaLin::global2local(), oofem::Node::hasSameLCS(), oofem::Quasicontinuum::homogenizationOfStiffMatrix(), oofem::MazarsMaterial::initDamaged(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::ConcreteDPM::initDamaged(), oofem::ConcreteDPM2::initDamaged(), oofem::FCMMaterial::initializeCrack(), oofem::AnisotropicMassTransferMaterial::initializeFrom(), oofem::SymmetryBarrier::initializeFrom(), oofem::AnisotropicLinearElasticMaterial::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::Node::initializeFrom(), oofem::Element::initializeFrom(), oofem::IntMatBilinearCZJanssonStatus::initTempStatus(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::HybridEI::interpGradLevelSet(), isFinite(), oofem::FRCFCMNL::isInElementProjection(), oofem::Triangle::isOrientedAnticlockwise(), oofem::FRCFCMNL::isStrengthExceeded(), jaco_(), oofem::TR1_2D_SUPG::LS_PCS_computedN(), oofem::FETISolver::masterMapRBM(), oofem::FETISolver::masterUnpackRBM(), oofem::HeMoBazNajMaterial::matcond1d(), oofem::HeMoTKMaterial::matcond1d(), oofem::HeMoKunzelMaterial::matcond1d(), oofem::HeMoBazNajMaterial::matcond2d(), oofem::HeMoTKMaterial::matcond2d(), oofem::HeMoKunzelMaterial::matcond2d(), oofem::HeMoBazNajMaterial::matcond3d(), oofem::HeMoTKMaterial::matcond3d(), oofem::HeMoKunzelMaterial::matcond3d(), oofem::MDMStatus::MDMStatus(), oofem::MisesMatStatus::MisesMatStatus(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_recoverValues(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::FETISolver::packRBM(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::LevelSetPCS::pcs_stage1(), oofem::RankineMat::performPlasticityReturn(), plusDyadSymmUpper(), plusDyadUnsym(), oofem::FloatArray::plusProduct(), plusProductSymmUpper(), plusProductUnsym(), oofem::AbaqusUserElement::postInitialize(), oofem::RCSDEMaterialStatus::printOutputAt(), oofem::RCSDMaterialStatus::printOutputAt(), oofem::FreeWarping::printOutputAt(), oofem::FCMMaterialStatus::printOutputAt(), oofem::AnisotropicDamageMaterialStatus::printOutputAt(), oofem::RCM2MaterialStatus::printOutputAt(), oofem::MDMStatus::printOutputAt(), oofem::Grid::printSolutionAsData(), printYourself(), printYourselfToFile(), oofem::PLHoopStressCirc::propagateInterface(), pY(), oofem::Skyline::rbmodes(), oofem::RCM2MaterialStatus::RCM2MaterialStatus(), oofem::OOFEMTXTInputRecord::readMatrix(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::Shell7Base::recoverShearStress(), oofem::ZZNodalRecoveryModel::recoverValues(), resizeWithData(), oofem::M1MaterialStatus::restoreContext(), oofem::PrescribedGenStrainShell7::setDeformationGradient(), oofem::MixedGradientPressureWeakPeriodic::setPrescribedDeviatoricGradientFromVoigt(), oofem::Grid::setPrescribedFieldValue(), oofem::PrescribedGenStrainShell7::setPrescribedGenStrainShell7Voigt(), oofem::PrescribedGradientHomogenization::setPrescribedGradientVoigt(), oofem::Grid::setSolutionValueAt(), oofem::Shell7Base::setupInitialNodeDirectors(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::Grid::setZeroValues(), oofem::SLEPcSolver::solve(), oofem::GJacobi::solve(), oofem::SubspaceIteration::solve(), solveForRhs(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::DEIDynamic::solveYourselfAt(), oofem::StructuralMaterial::sortPrincDirAndValCloseTo(), oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dTetLin::surfaceEvaldNdx(), oofem::FEI3dTetQuad::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEI3dTrLin::surfaceEvaldNdxi(), oofem::FEI3dTrQuad::surfaceEvaldNdxi(), oofem::FEI3dTrLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrQuad::surfaceGiveJacobianMatrixAt(), symmetrized(), oofem::tet21ghostsolid::tet21ghostsolid(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::SkylineUnsym::toFloatMatrix(), oofem::Skyline::toFloatMatrix(), oofem::Tr_Warp::transformCoordinates(), oofem::Quasicontinuum::transformStiffnessTensorToMatrix(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::Shell7Base::updateLayerTransvNormalStressSR(), oofem::Shell7Base::updateLayerTransvShearStressesSR(), oofem::Shell7Base::updateLayerTransvStressesSR(), oofem::LevelSetPCS::updatePosition(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), writeCSV(), oofem::SkylineUnsym::writeToFile(), oofem::Skyline::writeToFile(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix(), oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions(), oofem::TR_SHELL01::ZZErrorEstimatorI_computeLocalStress(), oofem::TR_SHELL02::ZZErrorEstimatorI_computeLocalStress(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct().
|
inline |
Coefficient access function.
Returns value of coefficient at given position of the receiver. Implements 1-based indexing.
i | Row position of coefficient. |
j | Column position of coefficient. |
Definition at line 187 of file floatmatrix.h.
void oofem::FloatMatrix::beDiagonal | ( | const FloatArray & | diag | ) |
Modifies receiver to be a diagonal matrix with the components specified in diag.
Definition at line 1433 of file floatmatrix.C.
References oofem::FloatArray::giveSize(), and resize().
Referenced by oofem::LineDistributedSpring::computeConstitutiveMatrixAt(), oofem::LumpedMassElement::computeLumpedMassMatrix(), oofem::NodalSpringElement::computeLumpedMassMatrix(), oofem::NodalSpringElement::computeStiffnessMatrix(), and oofem::WinklerMaterial::give3dBeamSubSoilStiffMtrx().
void oofem::FloatMatrix::beDyadicProductOf | ( | const FloatArray & | vec1, |
const FloatArray & | vec2 | ||
) |
Assigns to the receiver the dyadic product .
Grows or shrinks if necessary.
Definition at line 492 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), oofem::FloatArray::giveSize(), and RESIZE.
Referenced by oofem::Node2NodeContact::computeContactTangent(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::PrescribedGradientBCWeak::computeField(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::ContactElement::ContactElement(), oofem::FEI2dLineHermite::evaldNdx(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::MisesMatGrad::give3dMaterialStiffnessMatrix(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::MisesMat::give3dMaterialStiffnessMatrix(), oofem::TrabBoneNL3D::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::IsotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), and oofem::IntElLine1PF::solveForLocalDamage().
void oofem::FloatMatrix::beInverseOf | ( | const FloatMatrix & | src | ) |
Modifies receiver to become inverse of given parameter.
Size of receiver will be adjusted.
src | Matrix to be inverted. |
Definition at line 835 of file floatmatrix.C.
References at(), oofem::IntArray::givePointer(), oofem::FloatArray::givePointer(), givePointer(), isSquare(), nColumns, nRows, OOFEM_ERROR, RESIZE, and zero().
Referenced by oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::ConcreteDPM::computeAMatrix(), oofem::MITC4Shell::computeBmatrixAt(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::PlasticMaterial::computeConsistentModuli(), oofem::MazarsMaterial::computeDamageParam(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::MisesMat::computeGLPlasticStrain(), oofem::PolygonLine::computeIntersectionPoints(), oofem::BasicGeometry::computeLineDistance(), oofem::tet21ghostsolid::computeLoadVector(), computeReciprocalCondition(), oofem::HTSelement::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TrabBone3D::constructAnisoComplTensor(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI2dQuadLin::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::StructuralMaterial::give1dStressStiffMtrx(), oofem::StructuralMaterial::give2dBeamLayerStiffMtrx(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::HyperElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::TrabBoneEmbed::give3dMaterialStiffnessMatrix(), oofem::TrabBoneNL3D::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::MooneyRivlinMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MITC4Shell::givedNdx(), oofem::Shell7Base::giveDualBase(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::StructuralMaterial::giveFiberStiffMtrx(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_3d(), oofem::StructuralPythonMaterial::giveFirstPKStressVector_3d(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::MDM::giveIPValue(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::MooneyRivlinMaterial::givePlaneStrainStiffMtrx_dPdF(), oofem::StructuralMaterial::givePlaneStressStiffMtrx(), oofem::StructuralMaterial::givePlateLayerStiffMtrx(), oofem::PlasticMaterial::giveRealStressVector(), oofem::HyperElasticMaterial::giveRealStressVector_3d(), oofem::TrabBoneNLEmbed::giveRealStressVector_3d(), oofem::TrabBoneEmbed::giveRealStressVector_3d(), oofem::RheoChainMaterial::giveUnitComplianceMatrix(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::TrabBone3D::performPlasticityReturn(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::SubspaceIteration::solve(), oofem::FETISolver::solve(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().
void oofem::FloatMatrix::beLocalCoordSys | ( | const FloatArray & | normal | ) |
Makes receiver the local coordinate for the given normal.
Implemented for 2D and 3D.
normal | Normal (normalized). |
Definition at line 515 of file floatmatrix.C.
References oofem::FloatArray::add(), oofem::FloatArray::at(), at(), oofem::FloatArray::beVectorProductOf(), oofem::FloatArray::dotProduct(), oofem::FloatArray::giveSize(), oofem::FloatArray::normalize(), OOFEM_ERROR, and resize().
Referenced by oofem::ParticleTopologyDescription::calculateShortestDistance(), oofem::ParticleTopologyDescription::collectNeighbors(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::IntElSurfTr1::computeTransformationMatrixAt(), oofem::ParticleTopologyDescription::generatePSLG(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), and oofem::Shell7BaseXFEM::recoverShearStress().
void oofem::FloatMatrix::beMatrixForm | ( | const FloatArray & | aArray | ) |
Definition at line 1657 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), oofem::FloatArray::giveSize(), OOFEM_ERROR, and resize().
Referenced by oofem::SolidShell::computeBEmatrixAt(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::NLStructuralElement::computeCurrentVolume(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::SolidShell::computeEVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Shell7Base::computeStressMatrix(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::LinearElasticMaterial::giveEshelbyStressVector_PlaneStrain(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::StructuralPythonMaterial::giveFirstPKStressVector_3d(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::StructuralMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::Element::giveGlobalIPValue(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), and oofem::AnisotropicDamageMaterial::giveRealStressVector().
void oofem::FloatMatrix::beMatrixFormOfStress | ( | const FloatArray & | aArray | ) |
Reciever will be a 3x3 matrix formed from a vector with either 9 or 6 components.
Order of matrix components in vector: 11, 22, 33, 23, 13, 12, 32, 31, 21 If size(aArray) = 6, a symmetric matrix will be created.
aArray | Array to transform. |
Definition at line 1774 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), oofem::IntArray::givePointer(), oofem::FloatArray::givePointer(), givePointer(), oofem::FloatArray::giveSize(), nRows, OOFEM_ERROR, oofem::FloatArray::resize(), and resize().
Referenced by oofem::Shell7Base::computeCauchyStressVector(), oofem::SolidShell::computeGeometricStiffness(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::LinearElasticMaterial::giveEshelbyStressVector_PlaneStrain(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), and oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug().
void oofem::FloatMatrix::beNMatrixOf | ( | const FloatArray & | n, |
int | nsd | ||
) |
Assigns the receiver to be a repeated diagonal matrix.
n | Vector with components which will appear in respective diagonal. |
nsd | Number of spatial dimensions |
Definition at line 505 of file floatmatrix.C.
References oofem::FloatArray::giveSize(), and resize().
Referenced by oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::MITC4Shell::computeEdgeNMatrix(), oofem::StructuralElement::computeEdgeNMatrix(), oofem::PFEMElement2d::computeEdgeNMatrixAt(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGradientBCWeak::computeField(), oofem::TransportElement::computeLoadVector(), oofem::XfemElementInterface::computeNCohesive(), oofem::PhaseFieldElement::computeNd_matrixAt(), oofem::StructuralInterfaceElementPhF::computeNd_matrixAt(), oofem::PlaneStressStructuralElementEvaluator::computeNMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeNMatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::QDKTPlate::computeNmatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::Truss3d::computeNmatrixAt(), oofem::TransportElement::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::Tet1_3D_SUPG::computeNuMatrix(), oofem::TR21_2D_SUPG::computeNuMatrix(), oofem::Quad10_2D_SUPG::computeNuMatrix(), oofem::QDKTPlate::computeSurfaceNMatrix(), oofem::MITC4Shell::computeSurfaceNMatrix(), oofem::StructuralElement::computeSurfaceNMatrix(), oofem::Structural3DElement::computeSurfaceNMatrixAt(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::StokesFlowVelocityHomogenization::integrateNMatrix(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent(), oofem::MixedGradientPressureNeumann::integrateVolTangent(), and oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt().
void oofem::FloatMatrix::bePinvID | ( | ) |
Sets receiver to the inverse of scaling matrix P multiplied by the deviatoric projector ID.
Definition at line 1347 of file floatmatrix.C.
References resize(), and values.
Referenced by oofem::MisesMatGrad::give3dMaterialStiffnessMatrix(), and oofem::MisesMat::give3dMaterialStiffnessMatrix().
void oofem::FloatMatrix::beProductOf | ( | const FloatMatrix & | a, |
const FloatMatrix & | b | ||
) |
Assigns to the receiver product of .
Grows or shrinks if necessary.
Definition at line 337 of file floatmatrix.C.
References at(), givePointer(), nColumns, nRows, OOFEM_ERROR, and RESIZE.
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MB(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::HTSelement::computeAMatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::Shell7Base::computeCauchyStressVector(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::HTSelement::computeFMatrixAt(), oofem::SolidShell::computeGeometricStiffness(), oofem::MisesMat::computeGLPlasticStrain(), oofem::Tet1_3D_SUPG::computeGradUMatrix(), oofem::TR21_2D_SUPG::computeGradUMatrix(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::Beam2d::computeGtoLRotationMatrix(), oofem::Beam3d::computeGtoLRotationMatrix(), oofem::DofManager::computeM2GTransformation(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::RigidArmNode::computeMasterContribution(), oofem::PerfectlyPlasticMaterial::computePlasticStiffnessAt(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::HTSelement::computePuVectorAt(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::Shell7BaseXFEM::computeSectionalForcesAt(), oofem::Shell7Base::computeSectionalForcesAt(), oofem::Tr1Darcy::computeStiffnessMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::Beam2d::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::PFEMElement2d::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::Lattice2d::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::LIBeam3dNL::computeTempCurv(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7BaseXFEM::computeTripleProduct(), oofem::TransportGradientDirichlet::computeXi(), oofem::TrabBone3D::constructAnisoComplTensor(), oofem::TrabBone3D::constructAnisoFabricTensor(), oofem::TrabBone3D::constructAnisoStiffnessTensor(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::LargeStrainMasterMaterialGrad::give3dGprime(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::MooneyRivlinMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::LargeStrainMasterMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::StructuralPythonMaterial::giveFirstPKStressVector_3d(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::StructuralMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::GradDpElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::MDM::giveIPValue(), oofem::FEI3dWedgeLin::giveJacobianMatrixAt(), oofem::FEI3dHexaLin::giveJacobianMatrixAt(), oofem::FEI3dWedgeQuad::giveJacobianMatrixAt(), oofem::FEI3dTetQuad::giveJacobianMatrixAt(), oofem::FEI3dHexaQuad::giveJacobianMatrixAt(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::MooneyRivlinMaterial::givePlaneStrainStiffMtrx_dPdF(), oofem::PlasticMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::Element::giveRotationMatrix(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::Homogenize::herveZaoui(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::PLHoopStressCirc::propagateInterface(), rotatedWith(), oofem::MDM::rotateTensor4(), oofem::LIBeam3dNL::updateTempTriad(), and oofem::LIBeam3d2::updateTempTriad().
void oofem::FloatMatrix::beProductTOf | ( | const FloatMatrix & | a, |
const FloatMatrix & | b | ||
) |
Assigns to the receiver product of .
Grows or shrinks if necessary.
Definition at line 397 of file floatmatrix.C.
References at(), givePointer(), nColumns, nRows, OOFEM_ERROR, and RESIZE.
Referenced by oofem::StructuralInterfaceElementPhF::computeBd_matrixAt(), oofem::Shell7Base::computeCauchyStressVector(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Shell7Base::computeFAt(), oofem::SolidShell::computeGeometricStiffness(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::NURBSSpace3dElement::drawScalar(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI2dQuadLin::evaldNdx(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::LargeStrainMasterMaterialGrad::give3dKappaMatrix(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::MooneyRivlinMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MITC4Shell::givedNdx(), oofem::Shell7Base::giveDualBase(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::MooneyRivlinMaterial::givePlaneStrainStiffMtrx_dPdF(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), rotatedWith(), oofem::MDM::rotateTensor4(), and oofem::PrescribedGenStrainShell7::setDeformationGradient().
void oofem::FloatMatrix::beSubMatrixOf | ( | const FloatMatrix & | src, |
int | topRow, | ||
int | bottomRow, | ||
int | topCol, | ||
int | bottomCol | ||
) |
Assigns to the receiver the sub-matrix of another matrix.
src | Matrix from which sub-matrix is taken |
topRow | Index of top row, where sub matrix row index starts |
bottomRow | Index of bottom row, where sub matrix ends (including this row). |
topCol | Index of top column of sub-matrix. |
bottomCol | index of bottom column of sub-matrix. |
Definition at line 962 of file floatmatrix.C.
References at(), nColumns, nRows, OOFEM_ERROR, and resize().
Referenced by oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::NLStructuralElement::computeInitialStressMatrix(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::TransportGradientPeriodic::computeTangent(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MITC4Shell::givedNdx(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::StructuralMaterial::giveReducedMatrixForm(), oofem::StructuralMaterial::giveReducedSymMatrixForm(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::Shell7Base::recoverShearStress(), oofem::StructuralMaterialEvaluator::solveYourself(), and oofem::FluidMaterialEvaluator::solveYourself().
void oofem::FloatMatrix::beSubMatrixOf | ( | const FloatMatrix & | src, |
const IntArray & | indxRow, | ||
const IntArray & | indxCol | ||
) |
Modifies receiver to be a sub-matrix of another matrix.
src | Matrix from which sub-matrix is taken |
indxRow | Array of the row indices to be extracted |
indxCol | Array of the column indices to be extracted |
Definition at line 998 of file floatmatrix.C.
References oofem::IntArray::at(), at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::IntArray::giveSize(), oofem::IntArray::maximum(), oofem::IntArray::minimum(), OOFEM_ERROR, and resize().
void oofem::FloatMatrix::beTProductOf | ( | const FloatMatrix & | a, |
const FloatMatrix & | b | ||
) |
Assigns to the receiver product of .
Grows or shrinks if necessary.
Definition at line 367 of file floatmatrix.C.
References at(), givePointer(), nColumns, nRows, OOFEM_ERROR, and RESIZE.
Referenced by oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::HTSelement::computeAMatrixAt(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::SolidShell::computeEVector(), oofem::HTSelement::computeFMatrixAt(), oofem::MisesMat::computeGLPlasticStrain(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::RigidArmNode::computeMasterContribution(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::HTSelement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::TrPlanestressRotAllman::computeStiffnessMatrixZeroEnergyStabilization(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::Shell7BaseXFEM::computeTripleProduct(), oofem::TrabBone3D::constructAnisoComplTensor(), oofem::TrabBone3D::constructAnisoFabricTensor(), oofem::TrabBone3D::constructAnisoStiffnessTensor(), oofem::MooneyRivlinMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::Shell7Base::giveDualBase(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::LinearElasticMaterial::giveEshelbyStressVector_PlaneStrain(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::StructuralPythonMaterial::giveFirstPKStressVector_3d(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::StructuralMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::MooneyRivlinMaterial::givePlaneStrainStiffMtrx_dPdF(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::PLHoopStressCirc::propagateInterface(), rotatedWith(), and oofem::FETISolver::solve().
void oofem::FloatMatrix::beTranspositionOf | ( | const FloatMatrix & | src | ) |
Assigns to the receiver the transposition of parameter.
Grows or shrinks if necessary.
Definition at line 323 of file floatmatrix.C.
References at(), giveNumberOfColumns(), giveNumberOfRows(), and RESIZE.
Referenced by oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedMean::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::LinearConstraintBC::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PhaseFieldElement::computeBd_matrixAt(), oofem::QTrPlaneStrainGrad::computeBkappaMatrixAt(), oofem::QPlaneStressGrad::computeBkappaMatrixAt(), oofem::QPlaneStrainGrad::computeBkappaMatrixAt(), oofem::QTrPlaneStressGrad::computeBkappaMatrixAt(), oofem::QTruss1dGrad::computeBkappaMatrixAt(), oofem::QTRSpaceGrad::computeBkappaMatrixAt(), oofem::QWedgeGrad::computeBkappaMatrixAt(), oofem::QSpaceGrad::computeBkappaMatrixAt(), oofem::Truss1d::computeBmatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::TransportElement::computeGradientMatrixAt(), oofem::Tet1_3D_SUPG::computeGradPMatrix(), oofem::TR21_2D_SUPG::computeGradPMatrix(), oofem::Quad10_2D_SUPG::computeGradPMatrix(), oofem::Tr1Darcy::computeInternalForcesVector(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::Truss3d::computeLoadLEToLRotationMatrix(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::Tr1Darcy::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::HTSelement::computeSvMatrixAt(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::Shell7Base::computeTractionForce(), oofem::HTSelement::computeUgammaMatrixAt(), oofem::HTSelement::computeUvMatrixAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralMaterial::give2DStrainVectorTranformationMtrx(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::Shell7BaseXFEM::giveLocalCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveLocalNodeCoordsForExport(), oofem::StructuralMaterial::givePlaneStressVectorTranformationMtrx(), oofem::StructuralMaterial::giveStrainVectorTranformationMtrx(), oofem::StructuralMaterial::giveStressVectorTranformationMtrx(), oofem::IntMatPhaseField::giveTangents(), oofem::StrainVector::giveTranformationMtrx(), oofem::StressVector::giveTranformationMtrx(), oofem::LIBeam3d2::initializeFrom(), oofem::LIBeam3dNL2::initializeFrom(), oofem::LIBeam3dNL::initializeFrom(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), solveForRhs(), oofem::PetscSparseMtrx::timesT(), oofem::PetscSparseMtrx::toFloatMatrix(), oofem::TR_SHELL02::ZZErrorEstimatorI_computeLocalStress(), and oofem::TR_SHELL01::ZZErrorEstimatorI_computeLocalStress().
void oofem::FloatMatrix::beUnitMatrix | ( | ) |
Sets receiver to unity matrix.
Definition at line 1332 of file floatmatrix.C.
References at(), isSquare(), nColumns, nRows, OOFEM_ERROR, and zero().
Referenced by oofem::PrescribedGradientBCWeak::assemble(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Element::computeDofTransformationMatrix(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::MisesMat::computeGLPlasticStrain(), oofem::RigidArmNode::computeMasterContribution(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::StructuralInterfaceElement::computeTraction(), oofem::ElementSide::computeTransformation(), oofem::StructuralMaterial::convert_dSdE_2_dPdF(), oofem::VTKXMLExportModule::getCellVariableFromIS(), oofem::IntMatElastic::give3dStiffnessMatrix_dTdj(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::StructuralInterfaceElement::giveEngTraction(), oofem::StructuralInterfaceMaterial::giveEngTraction_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::IntMatCoulombContact::giveGeneralStiffnessMatrix(), oofem::CompoDamageMat::giveRealStressVector(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::StructuralMaterial::giveStiffnessMatrix(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::IntMatBilinearCZFagerstromStatus::initTempStatus(), oofem::IntMatBilinearCZFagerstromStatus::IntMatBilinearCZFagerstromStatus(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::LargeStrainMasterMaterialStatus::LargeStrainMasterMaterialStatus(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::GJacobi::solve(), and oofem::StructuralInterfaceMaterialStatus::StructuralInterfaceMaterialStatus().
void oofem::FloatMatrix::changeComponentOrder | ( | ) |
Swaps the indices in the 6x6 matrix such that it converts between OOFEM's and Abaqus' way of writing matrices.
Currently used to convert the 6x6 Jacobian from Abaqus UMAT to OOFEM.
Definition at line 1691 of file floatmatrix.C.
References at(), nColumns, and nRows.
Referenced by oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), and oofem::AbaqusUserMaterial::giveRealStressVector_3d().
void oofem::FloatMatrix::checkBounds | ( | int | i, |
int | j | ||
) | const |
Checks size of receiver towards requested bounds.
Current implementation will call exit(1), if positions are outside bounds.
i | Required number of rows. |
j | Required number of columns. |
Definition at line 189 of file floatmatrix.C.
References nColumns, nRows, and OOFEM_ERROR.
Referenced by isFinite().
|
inline |
Sets size of receiver to be an empty matrix. It will have zero rows and zero columns size.
Definition at line 516 of file floatmatrix.h.
Referenced by oofem::EngngModel::assemble(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::MPlasticMaterial::closestPointReturn(), oofem::SUPGElement2::computeAccelerationTerm_MB(), oofem::SUPGElement2::computeAccelerationTerm_MC(), oofem::TR21_2D_SUPG::computeAdvectionDeltaTerm(), oofem::Quad10_2D_SUPG::computeAdvectionDeltaTerm(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MB(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MC(), oofem::Quad10_2D_SUPG::computeAdvectionEpsilonTerm(), oofem::TR21_2D_SUPG::computeAdvectionTerm(), oofem::Quad10_2D_SUPG::computeAdvectionTerm(), oofem::TR1_2D_SUPG_AXI::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCLhsTerm_MB(), oofem::SUPGElement::computeBCLhsTerm_MB(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::LumpedMassElement::computeBmatrixAt(), oofem::NodalSpringElement::computeBmatrixAt(), oofem::SpringElement::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::TransportElement::computeCapacitySubMatrix(), oofem::LumpedMassElement::computeConstitutiveMatrixAt(), oofem::NodalSpringElement::computeConstitutiveMatrixAt(), oofem::SpringElement::computeConstitutiveMatrixAt(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MC(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::Element::computeDofTransformationMatrix(), oofem::SolidShell::computeEASBmatrixAt(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Element::computeGtoLRotationMatrix(), oofem::RankinePlasticMaterial::computeHardeningReducedModuli(), oofem::J2MPlasticMaterial::computeHardeningReducedModuli(), oofem::J2plasticMaterial::computeHardeningReducedModuli(), oofem::SUPGElement::computeHomogenizedReinforceTerm_MB(), oofem::SUPGElement::computeHomogenizedReinforceTerm_MC(), oofem::LumpedMassElement::computeInitialStressMatrix(), oofem::NodalSpringElement::computeInitialStressMatrix(), oofem::SpringElement::computeInitialStressMatrix(), oofem::NLStructuralElement::computeInitialStressMatrix(), oofem::TransportElement::computeIntSourceLHSMatrix(), oofem::TransportElement::computeIntSourceLHSSubMatrix(), oofem::Node::computeL2GTransformation(), oofem::SUPGElement2::computeLinearAdvectionTerm_MC(), oofem::StructuralElement::computeLoadGToLRotationMtrx(), oofem::LIBeam2d::computeLoadLEToLRotationMatrix(), oofem::LIBeam2dNL::computeLoadLEToLRotationMatrix(), oofem::LIBeam3d::computeLoadLEToLRotationMatrix(), oofem::LIBeam3dNL2::computeLoadLEToLRotationMatrix(), oofem::LIBeam3dNL::computeLoadLEToLRotationMatrix(), oofem::LIBeam3d2::computeLoadLEToLRotationMatrix(), oofem::StructuralElement::computeLoadLEToLRotationMatrix(), oofem::StructuralElement::computeLoadLSToLRotationMatrix(), oofem::SUPGElement2::computeLSICStabilizationTerm_MB(), oofem::TR21_2D_SUPG::computeLSICTerm(), oofem::Quad10_2D_SUPG::computeLSICTerm(), oofem::DofManager::computeM2GTransformation(), oofem::TR21_2D_SUPG::computeMassDeltaTerm(), oofem::Quad10_2D_SUPG::computeMassDeltaTerm(), oofem::Quad10_2D_SUPG::computeMassEpsilonTerm(), oofem::LumpedMassElement::computeNmatrixAt(), oofem::NodalSpringElement::computeNmatrixAt(), oofem::SpringElement::computeNmatrixAt(), oofem::TR1_2D_SUPG_AXI::computeOutFlowBCTerm_MB(), oofem::SUPGElement::computeOutFlowBCTerm_MB(), oofem::TR1_2D_SUPG_AXI::computePenetrationWithResistanceBCTerm_MB(), oofem::SUPGElement::computePenetrationWithResistanceBCTerm_MB(), oofem::SUPGElement2::computePressureTerm_MB(), oofem::SUPGElement2::computePressureTerm_MC(), oofem::RankinePlasticMaterial::computeReducedGradientMatrix(), oofem::TR1_2D_SUPG_AXI::computeSlipWithFrictionBCTerm_MB(), oofem::SUPGElement::computeSlipWithFrictionBCTerm_MB(), oofem::Tr1Darcy::computeStiffnessMatrix(), oofem::LumpedMassElement::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Beam2d::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::PFEMElement2d::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix_dd(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::Element::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::Element::computeTangentFromSurfaceLoad(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::FEI2dLineLin::evaldNdx(), oofem::FEI2dLineQuad::evaldNdx(), oofem::Line2BoundaryElement::giveCharacteristicMatrix(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::RCM2Material::giveCrackedStiffnessMatrix(), oofem::TwoFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::SolidShell::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Element::giveLocalCoordinateSystem(), oofem::PlasticMaterial::giveRealStressVector(), oofem::Element::giveRotationMatrix(), oofem::Shell7Base::giveSPRcontribution(), oofem::Element::initializeFrom(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::TransportGradientNeumann::integrateTangent(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent(), oofem::TR21_2D_SUPG::LS_PCS_computedN(), oofem::MatrixAssembler::matrixFromEdgeLoad(), oofem::EffectiveTangentAssembler::matrixFromEdgeLoad(), oofem::MatrixAssembler::matrixFromElement(), oofem::MatrixAssembler::matrixFromLoad(), oofem::TangentAssembler::matrixFromLoad(), oofem::EffectiveTangentAssembler::matrixFromLoad(), oofem::MatrixAssembler::matrixFromSurfaceLoad(), oofem::TrabBoneNL3D::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::MisesMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::RankineMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::Skyline::rbmodes(), oofem::OOFEMTXTInputRecord::readMatrix(), oofem::StructuralElementEvaluator::StructuralElementEvaluator(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNValProduct().
double oofem::FloatMatrix::computeFrobeniusNorm | ( | ) | const |
Computes the Frobenius norm of the receiver.
The Frobenius norm is defined as the square root of the sum of the absolute squares of its elements.
Definition at line 1613 of file floatmatrix.C.
References values.
Referenced by oofem::TransportGradientNeumann::computeTangent(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::RVEStokesFlow::giveIPValue(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::TR21_2D_SUPG::updateStabilizationCoeffs(), and oofem::Quad10_2D_SUPG::updateStabilizationCoeffs().
double oofem::FloatMatrix::computeNorm | ( | char | p | ) | const |
Computes the operator norm of the receiver.
p | Norm type, '1' for 1 norm, '2' for 2 norm. |
Definition at line 1618 of file floatmatrix.C.
References at(), giveNumberOfRows(), oofem::FloatArray::givePointer(), givePointer(), oofem::max(), nColumns, oofem::norm(), nRows, and OOFEM_ERROR.
Referenced by computeReciprocalCondition().
double oofem::FloatMatrix::computeReciprocalCondition | ( | char | p = '1' | ) | const |
Computes the conditioning of the receiver.
From 0 to 1, where 0 is singular and 1 best. The receiver must be square. Works identically as MATLAB/Octaves rcond().
p | Norm type, '1' for 1 norm, '2' for 2 norm. |
Definition at line 1737 of file floatmatrix.C.
References beInverseOf(), computeNorm(), giveDeterminant(), oofem::IntArray::givePointer(), oofem::FloatArray::givePointer(), givePointer(), isSquare(), nColumns, nRows, and OOFEM_ERROR.
Referenced by oofem::MeshQualityErrorEstimator::computeJacobianError().
void oofem::FloatMatrix::copyColumn | ( | FloatArray & | dest, |
int | c | ||
) | const |
Fetches the values from the specified column.
Output array is resized to fit column.
dest | Array to copy values to. |
c | Column to copy. |
Definition at line 662 of file floatmatrix.C.
References oofem::FloatArray::begin(), giveNumberOfColumns(), giveNumberOfRows(), OOFEM_ERROR, oofem::FloatArray::resize(), and values.
Referenced by oofem::FloatArray::beColumnOf(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::SparseLinearSystemNM::solve(), and oofem::PetscSparseMtrx::times().
void oofem::FloatMatrix::copySubVectorRow | ( | const FloatArray & | src, |
int | sr, | ||
int | sc | ||
) |
Copy (set) given vector to receiver row sr, starting at column sc.
src | Source matrix. |
sr | Starting row position. |
sc | Starting column position. |
Definition at line 677 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::FloatArray::giveSize(), oofem::max(), and resizeWithData().
Referenced by oofem::DofManager::computeM2LTransformation().
double oofem::FloatMatrix::giveDeterminant | ( | ) | const |
Returns the trace (sum of diagonal components) of the receiver.
The receiver should be a square matrix.
Definition at line 1408 of file floatmatrix.C.
References isSquare(), nColumns, nRows, OOFEM_ERROR, and values.
Referenced by oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Shell7Base::computeCauchyStressVector(), oofem::NLStructuralElement::computeCurrentVolume(), oofem::SolidShell::computeEASBmatrixAt(), oofem::PolygonLine::computeIntersectionPoints(), oofem::MeshQualityErrorEstimator::computeJacobianError(), oofem::tet21ghostsolid::computeLoadVector(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), computeReciprocalCondition(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::MITC4Shell::computeSurfaceVolumeAround(), oofem::MITC4Shell::computeVolumeAround(), oofem::Tr2Shell7XFEM::computeVolumeAroundLayer(), oofem::Tr2Shell7::computeVolumeAroundLayer(), oofem::NURBSInterpolation::evaldNdx(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::TSplineInterpolation::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::BSplineInterpolation::evaldNdx(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::HyperElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::MooneyRivlinMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_3d(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::MooneyRivlinMaterial::givePlaneStrainStiffMtrx_dPdF(), oofem::HyperElasticMaterial::giveRealStressVector_3d(), oofem::FEI3dWedgeQuad::giveTransformationJacobian(), oofem::FEI3dWedgeLin::giveTransformationJacobian(), oofem::FEInterpolation::giveTransformationJacobian(), and oofem::Triangle::isOrientedAnticlockwise().
|
inline |
Returns number of columns of receiver.
Definition at line 158 of file floatmatrix.h.
Referenced by addSubVectorCol(), addSubVectorRow(), oofem::SpoolesSparseMtrx::assemble(), oofem::SkylineUnsym::assemble(), oofem::SymCompCol::assemble(), oofem::Skyline::assemble(), oofem::CompCol::assemble(), assemble(), oofem::FloatArray::beProductOf(), beSubMatrixOf(), oofem::FloatArray::beSymVectorForm(), oofem::FloatArray::beSymVectorFormOfStrain(), oofem::FloatArray::beTProductOf(), beTranspositionOf(), oofem::FloatArray::beVectorForm(), oofem::TransportElement::computeBmatrixAt(), oofem::Element::computeDofTransformationMatrix(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::TransportElement::computeFlow(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::TransportGradientDirichlet::computeXi(), copyColumn(), oofem::Shell7Base::CopyIPvaluesToNodes(), copySubVectorRow(), oofem::drawIGAPatchDeformedGeometry(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::StructuralElement::giveCharacteristicVector(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::Shell7BaseXFEM::giveFictiousCZNodeCoordsForExport(), oofem::Shell7Base::giveFictiousCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousNodeCoordsForExport(), oofem::Shell7Base::giveFictiousNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedNodeCoordsForExport(), oofem::Shell7Base::giveFictiousUpdatedNodeCoordsForExport(), oofem::StructuralMaterial::giveIPValue(), oofem::Shell7Base::giveL2contribution(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::TR_SHELL02::giveRotationMatrix(), oofem::TR_SHELL01::giveRotationMatrix(), oofem::Element::giveRotationMatrix(), oofem::Shell7Base::giveTractionBC(), oofem::Homogenize::herveZaoui(), oofem::PrescribedGradientHomogenization::initializeFrom(), oofem::PrescribedGenStrainShell7::initializeFrom(), oofem::HybridEI::interpGradLevelSet(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_recoverValues(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::PetscSolver::petsc_solve(), oofem::FloatArray::plusProduct(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::FCMMaterialStatus::printOutputAt(), oofem::MDMStatus::printOutputAt(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), resizeWithData(), setColumn(), setSubMatrix(), setTSubMatrix(), oofem::Grid::setZeroValues(), oofem::SparseLinearSystemNM::solve(), solveForRhs(), oofem::PetscSparseMtrx::times(), oofem::PetscSparseMtrx::timesT(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::PFEMCorrectionRhsAssembler::vectorFromElement(), and oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct().
|
inline |
Returns number of rows of receiver.
Definition at line 156 of file floatmatrix.h.
Referenced by addSubVectorCol(), addSubVectorRow(), oofem::MDM::applyDamageToStiffness(), oofem::SpoolesSparseMtrx::assemble(), oofem::SkylineUnsym::assemble(), oofem::PetscSparseMtrx::assemble(), oofem::DynCompRow::assemble(), oofem::DynCompCol::assemble(), oofem::SymCompCol::assemble(), oofem::Skyline::assemble(), oofem::CompCol::assemble(), assemble(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::FloatArray::beProductOf(), beSubMatrixOf(), oofem::FloatArray::beTProductOf(), beTranspositionOf(), oofem::AnisotropicDamageMaterial::checkSymmetry(), oofem::Homogenize::checkVolFraction(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::PFEMElement2d::computeBMatrix(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::PlasticMaterial::computeConsistentModuli(), oofem::IntElLine2IntPen::computeCovarBaseVectorAt(), oofem::IntElLine1PF::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorAt(), oofem::IntElLine1::computeCovarBaseVectorAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::FRCFCM::computeCrackFibreAngle(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::PlasticMaterial::computeDiagModuli(), oofem::MPlasticMaterial::computeDiagModuli(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::Element::computeDofTransformationMatrix(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::TransportElement::computeFlow(), oofem::SolidShell::computeGeometricStiffness(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::NlDEIDynamic::computeMassMtrx(), computeNorm(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::PlaneStress2dXfem::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::TrPlaneStress2dXFEM::computeStiffnessMatrix(), oofem::QTrPlaneStress2dXFEM::computeStiffnessMatrix(), oofem::MITC4Shell::computeSurfaceVolumeAround(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), copyColumn(), copySubVectorRow(), oofem::AnisotropicDamageMaterial::correctBigValues(), oofem::Homogenize::counto(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI2dQuadLin::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::Homogenize::gamma(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::PrescribedGradientHomogenization::giveGradientVoigt(), oofem::StructuralInterfaceMaterial::giveInputRecord(), oofem::Element::giveInputRecord(), oofem::TrPlaneStress2dXFEM::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IDGMaterial::giveInternalLength(), oofem::FCMMaterial::giveIPValue(), oofem::FEInterpolation2d::giveJacobianMatrixAt(), oofem::FEI3dTetQuad::giveJacobianMatrixAt(), oofem::FEI3dHexaQuad::giveJacobianMatrixAt(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::PlasticMaterial::giveRealStressVector(), oofem::Element::giveRotationMatrix(), oofem::FluidDynamicMaterial::giveStiffnessMatrices(), oofem::Shell7Base::giveTractionBC(), oofem::Node::giveUpdatedCoordinate(), oofem::Homogenize::hansen(), oofem::Homogenize::hashinShtrikmanWalpole(), oofem::Homogenize::herveZaoui(), oofem::FCMMaterial::initializeCrack(), oofem::HybridEI::interpGradLevelSet(), jaco_(), oofem::Homogenize::kusterToksoz(), oofem::Homogenize::moriTanaka(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_recoverValues(), oofem::PetscSolver::petsc_solve(), oofem::FloatArray::plusProduct(), oofem::FCMMaterialStatus::printOutputAt(), oofem::AnisotropicDamageMaterialStatus::printOutputAt(), oofem::MDMStatus::printOutputAt(), resizeWithData(), oofem::Homogenize::reuss(), oofem::MDM::rotateTensor4(), oofem::Homogenize::selfConsistent(), setColumn(), oofem::MixedGradientPressureWeakPeriodic::setPrescribedDeviatoricGradientFromVoigt(), setSubMatrix(), setTSubMatrix(), oofem::Grid::setZeroValues(), oofem::GJacobi::solve(), oofem::SparseLinearSystemNM::solve(), solveForRhs(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::DEIDynamic::solveYourselfAt(), oofem::StructuralMaterial::sortPrincDirAndValCloseTo(), oofem::PetscSparseMtrx::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::PetscSparseMtrx::timesT(), oofem::Homogenize::voigt(), and oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix().
int oofem::FloatMatrix::givePackSize | ( | DataStream & | buff | ) | const |
Definition at line 1905 of file floatmatrix.C.
References oofem::DataStream::givePackSizeOfDouble(), oofem::DataStream::givePackSizeOfInt(), nColumns, and nRows.
Referenced by oofem::MDM::estimatePackSize().
|
inline |
Exposes the internal values of the matrix.
Should typically not be used outside of matrix classes.
Definition at line 558 of file floatmatrix.h.
Referenced by add(), addProductOf(), addTProductOf(), oofem::PetscSparseMtrx::assemble(), beInverseOf(), beMatrixFormOfStress(), oofem::FloatArray::beProductOf(), beProductOf(), beProductTOf(), oofem::FloatArray::beTProductOf(), beTProductOf(), computeNorm(), computeReciprocalCondition(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::PetscSolver::petsc_solve(), plusDyadSymmUpper(), plusDyadUnsym(), oofem::FloatArray::plusProduct(), plusProductSymmUpper(), plusProductUnsym(), solveForRhs(), subtract(), oofem::PetscSparseMtrx::times(), oofem::PetscSparseMtrx::timesT(), and oofem::PetscSparseMtrx::toFloatMatrix().
|
inline |
Definition at line 559 of file floatmatrix.h.
References oofem::operator<<().
double oofem::FloatMatrix::giveTrace | ( | ) | const |
Returns the trace of the receiver.
The receiver should be a square matrix.
Definition at line 1443 of file floatmatrix.C.
References isSquare(), nColumns, nRows, OOFEM_ERROR, and values.
Referenced by oofem::AnisotropicDamageMaterial::computeKappa(), oofem::AnisotropicDamageMaterial::computePlaneStressSigmaZ(), and oofem::AnisotropicDamageMaterialStatus::printOutputAt().
void oofem::FloatMatrix::hardResize | ( | int | r, |
int | c | ||
) |
Resizing that enforces reallocation of memory.
Data is zeroed.
r | Number of rows. |
c | Number of columns. |
Definition at line 1396 of file floatmatrix.C.
void oofem::FloatMatrix::initFromVector | ( | const FloatArray & | vector, |
bool | transposed | ||
) |
Assigns to receiver one column or one row matrix containing vector.
vector | Source vector. |
transposed | If false then (vector->giveSize(),1) FloatMatrix is assigned else (1,vector->giveSize()) FloatMatrix is assigned. |
Definition at line 1308 of file floatmatrix.C.
References oofem::FloatArray::giveSize(), nColumns, nRows, oofem::FloatArray::values, and values.
Referenced by oofem::PlasticMaterial::giveRealStressVector().
bool oofem::FloatMatrix::isFinite | ( | ) | const |
Returns true if no element is NAN or infinite.
Definition at line 209 of file floatmatrix.C.
References at(), checkBounds(), nRows, operator()(), and values.
Referenced by oofem::LSPrimaryVariableMapper::mapPrimaryVariables().
|
inline |
Tests for empty matrix.
Definition at line 162 of file floatmatrix.h.
Referenced by add(), oofem::EngngModel::assemble(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::TransportElement::computeBCMtrxAt(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::TrPlaneStrRot3d::computeLoadGToLRotationMtrx(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::TransportGradientPeriodic::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TR_SHELL02::giveCharacteristicMatrix(), oofem::TR_SHELL01::giveCharacteristicMatrix(), oofem::Element::giveGlobalIPValue(), oofem::TrPlaneStrRot3d::giveLocalCoordinates(), oofem::Element::giveLocalCoordinateSystem(), oofem::Structural3DElement::giveMaterialOrientationAt(), oofem::Structural2DElement::giveMaterialOrientationAt(), oofem::Element::giveRotationMatrix(), oofem::SUPGTangentAssembler::matrixFromElement(), plusDyadSymmUpper(), plusDyadUnsym(), plusProductSymmUpper(), plusProductUnsym(), oofem::AbaqusUserElement::postInitialize(), oofem::DEIDynamic::solveYourselfAt(), subtract(), oofem::DIIDynamic::timesMtrx(), and oofem::SUPGInternalForceAssembler::vectorFromElement().
|
inline |
Returns nonzero if receiver is square matrix.
Definition at line 160 of file floatmatrix.h.
Referenced by assemble(), beInverseOf(), beUnitMatrix(), computeReciprocalCondition(), oofem::StructuralElement::condense(), giveDeterminant(), giveTrace(), jaco_(), oofem::GJacobi::solve(), solveForRhs(), and oofem::StructuralMaterial::sortPrincDirAndValCloseTo().
bool oofem::FloatMatrix::jaco_ | ( | FloatArray & | eval, |
FloatMatrix & | v, | ||
int | nf | ||
) |
Computes eigenvalues and eigenvectors of receiver (must be symmetric) The receiver is preserved.
eval | Requested eigenvalues. |
v | Requested eigenvectors (stored colum wise). |
nf | Number of significant figures. |
Definition at line 1912 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), giveNumberOfRows(), isSquare(), OOFEM_ERROR, oofem::FloatArray::resize(), and resize().
Referenced by oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::MDM::computePDC(), oofem::AnisotropicDamageMaterial::computePlaneStressSigmaZ(), oofem::AnisotropicDamageMaterial::computePlaneStressStrain(), oofem::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha2(), and oofem::AnisotropicDamageMaterial::obtainAlpha3().
void oofem::FloatMatrix::negated | ( | ) |
Changes sign of receiver values.
Definition at line 1605 of file floatmatrix.C.
References values.
Referenced by oofem::PrescribedGradientBCNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::Node2NodeContact::computeContactTangent(), oofem::ContactDefinition::computeContactTangent(), oofem::TR1_2D_SUPG_AXI::computeOutFlowBCTerm_MB(), oofem::TR1_2D_SUPG::computeOutFlowBCTerm_MB(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientDirichlet::computeXi(), oofem::ContactElement::ContactElement(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::LinearElasticMaterial::giveEshelbyStressVector_PlaneStrain(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::FETISolver::solve(), and subtract().
|
inline |
Coefficient access function.
Returns l-value of coefficient at given position of the receiver. Implements 0-based indexing.
i | Row position of coefficient. |
j | Column position of coefficient. |
Definition at line 199 of file floatmatrix.h.
Referenced by isFinite().
|
inline |
Coefficient access function.
Implements 0-based indexing.
i | Row position of coefficient. |
j | Column position of coefficient. |
Definition at line 209 of file floatmatrix.h.
FloatMatrix & oofem::FloatMatrix::operator= | ( | std::initializer_list< std::initializer_list< double > > | mat | ) |
Assignment operator.
Definition at line 149 of file floatmatrix.C.
References nRows, OOFEM_ERROR, RESIZE, and values.
Referenced by add(), and subtract().
FloatMatrix & oofem::FloatMatrix::operator= | ( | std::initializer_list< FloatArray > | mat | ) |
Assignment operator.
Definition at line 169 of file floatmatrix.C.
References nRows, OOFEM_ERROR, RESIZE, and values.
|
inline |
Assignment operator, adjusts size of the receiver if necessary.
Definition at line 133 of file floatmatrix.h.
|
inline |
Definition at line 139 of file floatmatrix.h.
void oofem::FloatMatrix::plusDyadSymmUpper | ( | const FloatArray & | a, |
double | dV | ||
) |
Adds to the receiver the dyadic product .
If the receiver has zero size, it is expanded. Computes only the upper half of receiver.
a | Array a in equation. |
dV | Scaling factor. |
Definition at line 756 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), oofem::FloatArray::givePointer(), givePointer(), oofem::FloatArray::giveSize(), isNotEmpty(), nColumns, nRows, and values.
Referenced by oofem::TransportElement::computeBCSubMtrxAt(), oofem::TransportElement::computeCapacitySubMatrix(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::TransportElement::computeIntSourceLHSSubMatrix(), oofem::TR1_2D_SUPG_AXI::computePenetrationWithResistanceBCTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeSlipWithFrictionBCTerm_MB(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportGradientDirichlet::computeXi(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().
void oofem::FloatMatrix::plusDyadUnsym | ( | const FloatArray & | a, |
const FloatArray & | b, | ||
double | dV | ||
) |
Adds to the receiver the product .
If the receiver has zero size, it is expanded.
a | Array a in equation. |
b | Array b in equation. |
dV | Scaling factor. |
Definition at line 811 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), oofem::FloatArray::givePointer(), givePointer(), oofem::FloatArray::giveSize(), isNotEmpty(), nColumns, nRows, and values.
Referenced by oofem::ConcreteDPM2::computeDDRhoDDStress(), oofem::tet21ghostsolid::computeLoadVector(), oofem::TR1_2D_SUPG_AXI::computeOutFlowBCTerm_MB(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportGradientDirichlet::computeXi(), oofem::TutorialMaterial::give3dMaterialStiffnessMatrix(), oofem::GradDpElement::giveInternalForcesVector(), oofem::TransportGradientNeumann::integrateTangent(), oofem::Shell7Base::NodalRecoveryMI_computeNValProduct(), oofem::TrabBoneNL3D::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::MisesMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::RankineMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNValProduct().
void oofem::FloatMatrix::plusProductSymmUpper | ( | const FloatMatrix & | a, |
const FloatMatrix & | b, | ||
double | dV | ||
) |
Adds to the receiver the product .
If the receiver has zero size, it is expanded. Assumes that receiver and product are symmetric matrices. Computes only the upper half of receiver.
a | Matrix a in equation. |
b | Matrix b in equation. |
dV | Scaling factor. |
Definition at line 698 of file floatmatrix.C.
References at(), givePointer(), isNotEmpty(), nColumns, nRows, and values.
Referenced by oofem::Shell7Base::computeBulkTangentMatrix(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::NLStructuralElement::computeInitialStressMatrix(), oofem::SUPGElement2::computeLSICStabilizationTerm_MB(), oofem::TR21_2D_SUPG::computeLSICTerm(), oofem::Quad10_2D_SUPG::computeLSICTerm(), oofem::Shell7Base::computeMassMatrixNum(), oofem::SUPGElement2::computePressureTerm_MC(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::Beam2d::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix_dd(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::TransportGradientDirichlet::computeXi(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::GradDpElement::giveInternalForcesVector(), and oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix().
void oofem::FloatMatrix::plusProductUnsym | ( | const FloatMatrix & | a, |
const FloatMatrix & | b, | ||
double | dV | ||
) |
Adds to the receiver the product .
If the receiver has zero size, it is expanded.
a | Matrix a in equation. |
b | Matrix b in equation. |
dV | Scaling factor. |
Definition at line 780 of file floatmatrix.C.
References at(), givePointer(), isNotEmpty(), nColumns, nRows, and values.
Referenced by oofem::SUPGElement2::computeAccelerationTerm_MB(), oofem::SUPGElement2::computeAccelerationTerm_MC(), oofem::TR21_2D_SUPG::computeAdvectionDeltaTerm(), oofem::Quad10_2D_SUPG::computeAdvectionDeltaTerm(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MB(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MC(), oofem::Quad10_2D_SUPG::computeAdvectionEpsilonTerm(), oofem::TR21_2D_SUPG::computeAdvectionTerm(), oofem::Quad10_2D_SUPG::computeAdvectionTerm(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MC(), oofem::SolidShell::computeEASBmatrixAt(), oofem::SUPGElement2::computeLinearAdvectionTerm_MC(), oofem::TR21_2D_SUPG::computeMassDeltaTerm(), oofem::Quad10_2D_SUPG::computeMassDeltaTerm(), oofem::Quad10_2D_SUPG::computeMassEpsilonTerm(), oofem::SUPGElement2::computePressureTerm_MB(), oofem::Tr1Darcy::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::PFEMElement2d::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::Lattice2d::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::GradDpElement::giveInternalForcesVector(), and oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent().
void oofem::FloatMatrix::printYourself | ( | ) | const |
Prints matrix to stdout. Useful for debugging.
Definition at line 1458 of file floatmatrix.C.
References at(), nColumns, and nRows.
Referenced by oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::SkylineUnsym::printYourself(), oofem::Skyline::printYourself(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::GJacobi::solve(), oofem::SubspaceIteration::solve(), and oofem::StructuralMaterialEvaluator::solveYourself().
void oofem::FloatMatrix::printYourself | ( | const std::string & | name | ) | const |
Print receiver on stdout with custom name.
name | Display name of reciever. |
Definition at line 1499 of file floatmatrix.C.
void oofem::FloatMatrix::printYourselfToFile | ( | const std::string | filename, |
const bool | showDimensions = true |
||
) | const |
Print matrix to file.
filename | Output filename showDimensions Determines if dimensions should be included in output. Default is true. |
Definition at line 1477 of file floatmatrix.C.
References at(), nColumns, nRows, and OOFEM_ERROR.
Referenced by oofem::tet21ghostsolid::computeStiffnessMatrix().
void oofem::FloatMatrix::pY | ( | ) | const |
Higher accuracy than printYourself.
Definition at line 1524 of file floatmatrix.C.
void oofem::FloatMatrix::resize | ( | int | rows, |
int | cols | ||
) |
Checks size of receiver towards requested bounds.
If dimension mismatch, size is adjusted accordingly. Content is always zeroed.
rows | New number of rows. |
cols | New number of columns. |
Definition at line 1358 of file floatmatrix.C.
References nColumns, nRows, and values.
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::AnisotropicDamageMaterialStatus::AnisotropicDamageMaterialStatus(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::Beam3d::B3SSMI_getUnknownsGtoLRotationMatrix(), beDiagonal(), beLocalCoordSys(), beMatrixForm(), beMatrixFormOfStress(), beNMatrixOf(), bePinvID(), beSubMatrixOf(), oofem::StructuralPythonMaterial::callTangentFunction(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::Tr2Shell7::compareMatrices(), oofem::ConcreteDPM2::compute1dJacobian(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MC(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::TransportElement::computeBCMtrxAt(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::Quad1PlaneStrain::computeBHmatrixAt(), oofem::PlaneStress2d::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::Tet1_3D_SUPG::computeBMatrix(), oofem::PFEMElement2d::computeBMatrix(), oofem::TR21_2D_SUPG::computeBMatrix(), oofem::Quad10_2D_SUPG::computeBMatrix(), oofem::LSpaceBB::computeBmatrixAt(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBmatrixAt(), oofem::TrPlanestressRotAllman::computeBmatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::Tr_Warp::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::Quad2PlateSubSoil::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::CCTPlate::computeBmatrixAt(), oofem::QDKTPlate::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElem2dQuad::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::Tria1PlateSubSoil::computeBmatrixAt(), oofem::DKTPlate::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::Quad1PlateSubSoil::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::LIBeam2d::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::PlaneStress2d::computeBmatrixAt(), oofem::LIBeam2dNL::computeBmatrixAt(), oofem::LIBeam3d::computeBmatrixAt(), oofem::Truss3d::computeBmatrixAt(), oofem::Quad1Mindlin::computeBmatrixAt(), oofem::tet21ghostsolid::computeBmatrixAt(), oofem::Truss2d::computeBmatrixAt(), oofem::MITC4Shell::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::computeBmatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::TR1_2D_SUPG_AXI::computeBMtrx(), oofem::TR1_2D_SUPG2_AXI::computeBMtrx(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::Lattice2d_mt::computeCapacityMatrix(), oofem::TransportElement::computeCapacityMatrix(), oofem::FreeWarping::computeCenterOfGravity(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::Lattice2d_mt::computeConductivityMatrix(), oofem::TransportElement::computeConductivityMatrix(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::Beam2d::computeConsistentMassMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::AbaqusUserElement::computeConsistentMassMatrix(), oofem::TR1_2D_CBS::computeConsistentMassMtrx(), oofem::PlasticMaterial::computeConsistentModuli(), oofem::LineDistributedSpring::computeConstitutiveMatrixAt(), oofem::Node2NodeContactL::computeContactTangent(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::IntElLine1PhF::computeCovarBaseVectorsAt(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::ConcreteDPM2::computeDDGDDInv(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::PlasticMaterial::computeDiagModuli(), oofem::MPlasticMaterial::computeDiagModuli(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MC(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::Tet1_3D_SUPG::computeDivTauMatrix(), oofem::TR21_2D_SUPG::computeDivTauMatrix(), oofem::Quad10_2D_SUPG::computeDivTauMatrix(), oofem::Tet1_3D_SUPG::computeDivUMatrix(), oofem::TR21_2D_SUPG::computeDivUMatrix(), oofem::Quad10_2D_SUPG::computeDivUMatrix(), oofem::Element::computeDofTransformationMatrix(), oofem::SolidShell::computeEASBmatrixAt(), oofem::DKTPlate::computeEdgeNMatrix(), oofem::TrPlanestressRotAllman::computeEgdeNMatrixAt(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::TransportElement::computeFlow(), oofem::SolidShell::computeGeometricStiffness(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::MisesMat::computeGLPlasticStrain(), oofem::IntElLine1PF::computeGMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Lattice2d_mt::computeGradientMatrixAt(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::LIBeam2dNL::computeGtoLRotationMatrix(), oofem::LIBeam2d::computeGtoLRotationMatrix(), oofem::LIBeam3d::computeGtoLRotationMatrix(), oofem::LIBeam3d2::computeGtoLRotationMatrix(), oofem::RerShell::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::InterfaceElem2dLin::computeGtoLRotationMatrix(), oofem::InterfaceElem2dQuad::computeGtoLRotationMatrix(), oofem::InterfaceElement3dTrLin::computeGtoLRotationMatrix(), oofem::TrPlanestressRotAllman3d::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::Lattice2d::computeGtoLRotationMatrix(), oofem::SpringElement::computeGtoLRotationMatrix(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::Beam2d::computeGtoLRotationMatrix(), oofem::Beam3d::computeGtoLRotationMatrix(), oofem::J2MPlasticMaterial::computeHardeningReducedModuli(), oofem::J2plasticMaterial::computeHardeningReducedModuli(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::TransportElement::computeIntSourceLHSMatrix(), oofem::ConcreteDPM2::computeJacobian(), oofem::Node::computeL2GTransformation(), oofem::Shell7Base::computeLambdaGMatrices(), oofem::Shell7BaseXFEM::computeLambdaGMatricesDis(), oofem::Shell7Base::computeLambdaNMatrix(), oofem::Shell7BaseXFEM::computeLambdaNMatrixDis(), oofem::InterfaceElement3dTrLin::computeLCS(), oofem::Quad1MindlinShell3D::computeLCS(), oofem::TR1_2D_SUPG_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeLinearAdvectionTerm_MC(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::TrPlaneStrRot3d::computeLoadGToLRotationMtrx(), oofem::TrPlanestressRotAllman3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadGToLRotationMtrx(), oofem::CCTPlate3d::computeLoadGToLRotationMtrx(), oofem::LinQuad3DPlaneStress::computeLoadGToLRotationMtrx(), oofem::LIBeam2d::computeLoadGToLRotationMtrx(), oofem::LIBeam2dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d::computeLoadGToLRotationMtrx(), oofem::MITC4Shell::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL2::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d2::computeLoadGToLRotationMtrx(), oofem::Beam3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadLEToLRotationMatrix(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::CCTPlate::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::Quad1Mindlin::computeLoadLEToLRotationMatrix(), oofem::Truss2d::computeLoadLEToLRotationMatrix(), oofem::QDKTPlate::computeLoadLEToLRotationMatrix(), oofem::DKTPlate::computeLoadLEToLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLoadLEToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::MDM::computeLocalDamageTensor(), oofem::TR1_2D_SUPG_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2::computeLSICStabilizationTerm_MB(), oofem::MITC4Shell::computeLToDirectorRotationMatrix(), oofem::LIBeam2dNL::computeLumpedMassMatrix(), oofem::LIBeam3d::computeLumpedMassMatrix(), oofem::LIBeam2d::computeLumpedMassMatrix(), oofem::InterfaceElem1d::computeLumpedMassMatrix(), oofem::LumpedMassElement::computeLumpedMassMatrix(), oofem::Truss3d::computeLumpedMassMatrix(), oofem::Truss1d::computeLumpedMassMatrix(), oofem::LTRSpace::computeLumpedMassMatrix(), oofem::Truss2d::computeLumpedMassMatrix(), oofem::RerShell::computeLumpedMassMatrix(), oofem::LIBeam3dNL::computeLumpedMassMatrix(), oofem::LIBeam3dNL2::computeLumpedMassMatrix(), oofem::NodalSpringElement::computeLumpedMassMatrix(), oofem::LIBeam3d2::computeLumpedMassMatrix(), oofem::SpringElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::Quad1Mindlin::computeLumpedMassMatrix(), oofem::Quad1MindlinShell3D::computeLumpedMassMatrix(), oofem::CCTPlate::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::DKTPlate::computeLumpedMassMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::PhaseFieldElement::computeNd_matrixAt(), oofem::LIBeam2dNL::computeNLBMatrixAt(), oofem::TrPlaneStrRot::computeNmatrixAt(), oofem::TrPlanestressRotAllman::computeNmatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::CCTPlate::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::LIBeam2d::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::LIBeam2dNL::computeNmatrixAt(), oofem::LIBeam3d::computeNmatrixAt(), oofem::Truss1d::computeNmatrixAt(), oofem::MITC4Shell::computeNmatrixAt(), oofem::Truss2d::computeNmatrixAt(), oofem::IntElPoint::computeNmatrixAt(), oofem::LIBeam3dNL2::computeNmatrixAt(), oofem::LIBeam3dNL::computeNmatrixAt(), oofem::RerShell::computeNmatrixAt(), oofem::LIBeam3d2::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::Lattice2d_mt::computeNSubMatrixAt(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::WeakPeriodicBoundaryCondition::computeOrthogonalBasis(), oofem::TR1_2D_SUPG::computeOutFlowBCTerm_MB(), oofem::HTSelement::computeOutwardNormalMatrix(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::MDM::computePDC(), oofem::TR1_2D_SUPG::computePenetrationWithResistanceBCTerm_MB(), oofem::AnisotropicDamageMaterial::computePlaneStressSigmaZ(), oofem::AnisotropicDamageMaterial::computePlaneStressStrain(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::TR1_2D_CBS::computePressureLhs(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG::computePressureTerm_MB(), oofem::TR1_2D_SUPG2::computePressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG::computePressureTerm_MC(), oofem::TR1_2D_SUPG2::computePressureTerm_MC(), oofem::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::Masonry02::computeReducedElasticModuli(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSKGradientMatrix(), oofem::Masonry02::computeReducedSKGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::Masonry02::computeReducedSSGradientMatrix(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrxFromQuaternion(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::TR1_2D_SUPG::computeSlipWithFrictionBCTerm_MB(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::GradDpElement::computeStiffnessMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix(), oofem::SpringElement::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::MITC4Shell::computeStiffnessMatrix(), oofem::Lattice2d::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::TrPlaneStrRot3d::computeSurfaceNMatrixAt(), oofem::CCTPlate3d::computeSurfaceNMatrixAt(), oofem::DKTPlate3d::computeSurfaceNMatrixAt(), oofem::HTSelement::computeSvMatrixAt(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::ElementSide::computeTransformation(), oofem::Line::computeTransformationMatrix(), oofem::IntElLine1PF::computeTransformationMatrixAt(), oofem::IntElLine1PhF::computeTransformationMatrixAt(), oofem::IntElLine1::computeTransformationMatrixAt(), oofem::IntElPoint::computeTransformationMatrixAt(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::DKTPlate::computeVertexBendingMoments(), oofem::TransportGradientDirichlet::computeXi(), oofem::LIBeam3dNL::computeXMtrx(), oofem::LIBeam3dNL2::computeXMtrx(), oofem::TrabBone3D::constructAnisoComplTensor(), oofem::TrabBone3D::constructFabricTransformationMatrix(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), oofem::TrabBoneEmbed::constructIsoComplTensor(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::TrabBone3D::constructNormAdjustTensor(), oofem::TrabBone3D::constructStiffnessTransformationMatrix(), oofem::LargeStrainMasterMaterial::constructTransformationMatrix(), oofem::ContactElement::ContactElement(), oofem::StructuralMaterial::convert_dSdE_2_dPdF(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::BSplineInterpolation::dersBasisFuns(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::CrackExportModule::doOutput(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7Base::edgeComputeNmatrixAt(), oofem::Shell7Base::edgeEvalCovarBaseVectorsAt(), oofem::FEI3dHexaLin::edgeEvaldNdx(), oofem::FEI3dTetLin::edgeEvaldNdx(), oofem::FEI3dLineLin::edgeEvaldNdx(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::PrescribedGenStrainShell7::evalCovarBaseVectorsAt(), oofem::Shell7Base::evalCovarBaseVectorsAt(), oofem::FEI2dTrQuad::evald2Ndx2(), oofem::FEI3dLineLin::evald2Ndx2(), oofem::FEI1dHermite::evald2Ndx2(), oofem::NURBSInterpolation::evaldNdx(), oofem::FEI2dQuadConst::evaldNdx(), oofem::FEI2dTrConst::evaldNdx(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI3dTetLin::evaldNdx(), oofem::FEI2dTrLin::evaldNdx(), oofem::FEI3dLineLin::evaldNdx(), oofem::FEI1dHermite::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI1dLin::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::TSplineInterpolation::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::BSplineInterpolation::evaldNdx(), oofem::FEI3dTetQuad::evaldNdxi(), oofem::FEI2dLineLin::evaldNdxi(), oofem::FEI2dLineQuad::evaldNdxi(), oofem::FEI2dTrQuad::evaldNdxi(), oofem::FEI2dQuadLin::evaldNdxi(), oofem::FEI2dQuadQuad::evaldNdxi(), oofem::Shell7Base::evalInitialCovarBaseVectorsAt(), oofem::PrescribedGenStrainShell7::evalInitialCovarBaseVectorsAt(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncDerivAt(), oofem::PrescribedGenStrainShell7::evaluateHigherOrderContribution(), oofem::CohesiveSurface3d::evaluateLocalCoordinateSystem(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::RankineMat::evaluatePlaneStressStiffMtrx(), oofem::VTKExportModule::exportCellVars(), oofem::FCMMaterialStatus::FCMMaterialStatus(), oofem::MDM::formTransformationMatrix(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase2D(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase3D(), oofem::VTKXMLExportModule::getCellVariableFromIS(), oofem::RotatingBoundary::give(), oofem::IDGMaterial::give1dGprime(), oofem::MisesMatGrad::give1dGprime(), oofem::IDGMaterial::give1dKappaMatrix(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_dTdj(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng(), oofem::CebFipSlip90Material::give1dStiffnessMatrix_Eng(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng_Num(), oofem::IDGMaterial::give1dStressStiffMtrx(), oofem::MisesMatGrad::give1dStressStiffMtrx(), oofem::MisesMat::give1dStressStiffMtrx(), oofem::MisesMatNl::give1dStressStiffMtrx(), oofem::TrabBoneMaterial::give1dStressStiffMtrx(), oofem::SteelRelaxMat::give1dStressStiffMtrx(), oofem::IsotropicLinearElasticMaterial::give1dStressStiffMtrx(), oofem::RankineMat::give1dStressStiffMtrx(), oofem::StructuralMaterial::give1dStressStiffMtrx(), oofem::ConcreteDPM2::give1dStressStiffMtrx(), oofem::SimpleCrossSection::give2dBeamStiffMtrx(), oofem::LayeredCrossSection::give2dBeamStiffMtrx(), oofem::SimpleCrossSection::give2dPlateStiffMtrx(), oofem::LayeredCrossSection::give2dPlateStiffMtrx(), oofem::WinklerPasternakMaterial::give2dPlateSubSoilStiffMtrx(), oofem::WinklerMaterial::give2dPlateSubSoilStiffMtrx(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_dTdj(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_dTdj_Num(), oofem::IntMatIsoDamage::give2dStiffnessMatrix_Eng(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng_Num(), oofem::StructuralMaterial::give2DStrainVectorTranformationMtrx(), oofem::SimpleCrossSection::give3dBeamStiffMtrx(), oofem::FiberedCrossSection::give3dBeamStiffMtrx(), oofem::LayeredCrossSection::give3dDegeneratedShellStiffMtrx(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::MisesMatGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::OrthotropicLinearElasticMaterial::give3dLocalMaterialStiffnessMatrix(), oofem::HyperElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::SimpleVitrificationMaterial::give3dMaterialStiffnessMatrix(), oofem::M1Material::give3dMaterialStiffnessMatrix(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::TrabBoneEmbed::give3dMaterialStiffnessMatrix(), oofem::TrabBoneNL3D::give3dMaterialStiffnessMatrix(), oofem::IsotropicLinearElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::MicroplaneMaterial::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::AnisotropicDamageMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::SimpleCrossSection::give3dShellStiffMtrx(), oofem::LayeredCrossSection::give3dShellStiffMtrx(), oofem::IntMatDummyCZ::give3dStiffnessMatrix_dTdj(), oofem::IntMatElastic::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZElastic::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_dTdj_Num(), oofem::CohesiveInterfaceMaterial::give3dStiffnessMatrix_Eng(), oofem::IntMatPhaseField::give3dStiffnessMatrix_Eng(), oofem::SimpleInterfaceMaterial::give3dStiffnessMatrix_Eng(), oofem::ExpCZMaterial::give3dStiffnessMatrix_Eng(), oofem::BondCEBMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial_2::give3dStiffnessMatrix_Eng(), oofem::IntMatIsoDamage::give3dStiffnessMatrix_Eng(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_Eng_Num(), oofem::IsotropicMoistureTransferMaterial::giveCharacteristicMatrix(), oofem::SUPGElement2::giveCharacteristicMatrix(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::IsotropicHeatTransferMaterial::giveCharacteristicMatrix(), oofem::PFEMElement::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TR_SHELL02::giveCharacteristicMatrix(), oofem::TR_SHELL01::giveCharacteristicMatrix(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::MITC4Shell::giveCharacteristicTensor(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::RCM2Material::giveCrackedStiffnessMatrix(), oofem::FEI2dQuadBiQuad::giveDerivatives(), oofem::TutorialMaterial::giveDeviatoricProjectionMatrix(), oofem::NewtonianFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::BinghamFluidMaterial2::giveDeviatoricStiffnessMatrix(), oofem::MITC4Shell::giveDirectorVectors(), oofem::IntElSurfTr1::giveDofManDofIDMask(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::LatticeDamage2d::giveElasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::StructuralMaterial::giveFullSymMatrixForm(), oofem::IntMatCoulombContact::giveGeneralStiffnessMatrix(), oofem::StructuralInterfaceMaterial::giveInputRecord(), oofem::GradDpElement::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::IDGMaterial::giveInternalLength(), oofem::TrabBoneGrad3D::giveInternalLength(), oofem::RankineMatGrad::giveInternalLength(), oofem::MisesMatGrad::giveInternalLength(), oofem::IDGMaterial::giveInternalLengthDerivative(), oofem::tet21ghostsolid::giveIPValue(), oofem::MITC4Shell::giveJacobian(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::FEI3dWedgeLin::giveJacobianMatrixAt(), oofem::FEInterpolation2d::giveJacobianMatrixAt(), oofem::FEI3dLineLin::giveJacobianMatrixAt(), oofem::FEI3dHexaLin::giveJacobianMatrixAt(), oofem::TSplineInterpolation::giveJacobianMatrixAt(), oofem::FEI2dLineQuad::giveJacobianMatrixAt(), oofem::FEI3dWedgeQuad::giveJacobianMatrixAt(), oofem::FEI3dTetQuad::giveJacobianMatrixAt(), oofem::FEI3dHexaQuad::giveJacobianMatrixAt(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::Shell7Base::giveL2contribution(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Lattice2d::giveLocalCoordinateSystem(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::Truss2d::giveLocalCoordinateSystem(), oofem::Beam2d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::FCMMaterial::giveLocalCrackedStiffnessMatrix(), oofem::FEI3dHexaTriQuad::giveLocalDerivative(), oofem::FEI3dHexaLin::giveLocalDerivative(), oofem::FEI3dWedgeQuad::giveLocalDerivative(), oofem::FEI3dWedgeLin::giveLocalDerivative(), oofem::FEI3dHexaQuad::giveLocalDerivative(), oofem::FEI3dTrQuad::giveLocalNodeCoords(), oofem::FEI3dWedgeQuad::giveLocalNodeCoords(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::MazarsMaterial::giveNormalBlockOfElasticCompliance(), oofem::IDNLMaterial::giveNormalElasticStiffnessMatrix(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), oofem::IDGMaterial::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::IDGMaterial::givePlaneStrainKappaMatrix(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::IsotropicLinearElasticMaterial::givePlaneStrainStiffMtrx(), oofem::StructuralMaterial::givePlaneStrainStiffMtrx(), oofem::MooneyRivlinMaterial::givePlaneStrainStiffMtrx_dPdF(), oofem::IDGMaterial::givePlaneStressGprime(), oofem::RankineMatGrad::givePlaneStressGprime(), oofem::IDGMaterial::givePlaneStressKappaMatrix(), oofem::RankineMatGrad::givePlaneStressKappaMatrix(), oofem::IsotropicLinearElasticMaterial::givePlaneStressStiffMtrx(), oofem::AnisotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::StructuralMaterial::givePlaneStressStiffMtrx(), oofem::StructuralMaterial::givePlaneStressVectorTranformationMtrx(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::CompoDamageMat::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::TrabBoneNLEmbed::giveRealStressVector_3d(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::TR_SHELL02::giveRotationMatrix(), oofem::TR_SHELL01::giveRotationMatrix(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::LatticeDamage2d::giveSecantStiffnessMatrix(), oofem::StructuralMaterial::giveStiffnessMatrix(), oofem::LayeredCrossSection::giveStiffnessMatrix_PlaneStress(), oofem::StructuralMaterial::giveStrainVectorTranformationMtrx(), oofem::StructuralMaterial::giveStressVectorTranformationMtrx(), oofem::IntMatPhaseField::giveTangents(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::StrainVector::giveTranformationMtrx(), oofem::StressVector::giveTranformationMtrx(), oofem::CompoDamageMat::giveUnrotated3dMaterialStiffnessMatrix(), oofem::DruckerPragerPlasticitySM::giveVertexAlgorithmicStiffMatrix(), oofem::Shell7Base::giveZ2integratedPolynomial2GradientForStressRecAt(), oofem::MazarsMaterial::initDamaged(), oofem::AnisotropicMassTransferMaterial::initializeFrom(), oofem::SymmetryBarrier::initializeFrom(), oofem::Element::initializeFrom(), oofem::IntMatBilinearCZJanssonStatus::initTempStatus(), oofem::IntMatBilinearCZFagerstromStatus::initTempStatus(), oofem::ParticleTopologyDescription::instanciateYourself(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), oofem::IntMatBilinearCZFagerstromStatus::IntMatBilinearCZFagerstromStatus(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), jaco_(), oofem::TR1_2D_SUPG::LS_PCS_computedN(), oofem::HeMoBazNajMaterial::matcond1d(), oofem::HeMoTKMaterial::matcond1d(), oofem::HeMoKunzelMaterial::matcond1d(), oofem::HeMoBazNajMaterial::matcond2d(), oofem::HeMoTKMaterial::matcond2d(), oofem::HeMoKunzelMaterial::matcond2d(), oofem::HeMoBazNajMaterial::matcond3d(), oofem::HeMoTKMaterial::matcond3d(), oofem::HeMoKunzelMaterial::matcond3d(), oofem::SUPGTangentAssembler::matrixFromElement(), oofem::MisesMatStatus::MisesMatStatus(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::PetscSolver::petsc_solve(), oofem::SolidShell::postInitialize(), oofem::AbaqusUserElement::postInitialize(), oofem::Skyline::rbmodes(), oofem::OOFEMTXTInputRecord::readMatrix(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::M1MaterialStatus::restoreContext(), oofem::PrescribedGenStrainShell7::setPrescribedGenStrainShell7Voigt(), oofem::PrescribedGradientHomogenization::setPrescribedGradientVoigt(), oofem::SLEPcSolver::solve(), oofem::GJacobi::solve(), oofem::SparseLinearSystemNM::solve(), oofem::InverseIteration::solve(), oofem::SubspaceIteration::solve(), oofem::FETISolver::solve(), oofem::EigenValueDynamic::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dTetLin::surfaceEvaldNdx(), oofem::FEI3dTetQuad::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEI3dTrLin::surfaceEvaldNdxi(), oofem::FEI3dTrQuad::surfaceEvaldNdxi(), oofem::FEI3dTrLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrQuad::surfaceGiveJacobianMatrixAt(), oofem::tet21ghostsolid::tet21ghostsolid(), oofem::PetscSparseMtrx::times(), oofem::PetscSparseMtrx::timesT(), oofem::SkylineUnsym::toFloatMatrix(), oofem::Skyline::toFloatMatrix(), oofem::TrabBone3DStatus::TrabBone3DStatus(), oofem::TrabBoneEmbedStatus::TrabBoneEmbedStatus(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix(), oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().
void oofem::FloatMatrix::resizeWithData | ( | int | rows, |
int | columns | ||
) |
Checks size of receiver towards requested bounds.
If dimension mismatch, size is adjusted accordingly. Note: New coefficients are initialized to zero, old are kept.
Definition at line 1369 of file floatmatrix.C.
References at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::min(), nColumns, nRows, and values.
Referenced by addSubVectorCol(), addSubVectorRow(), oofem::Element::computeDofTransformationMatrix(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), copySubVectorRow(), oofem::PrescribedGradient::give(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::SimpleCrossSection::giveMembraneRotStiffMtrx(), and oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct().
contextIOResultType oofem::FloatMatrix::restoreYourself | ( | DataStream & | stream | ) |
Definition at line 1877 of file floatmatrix.C.
References oofem::CIO_IOERR, oofem::CIO_OK, nColumns, nRows, oofem::DataStream::read(), and values.
Referenced by oofem::EigenValueDynamic::restoreContext(), oofem::RCSDEMaterialStatus::restoreContext(), oofem::RCSDMaterialStatus::restoreContext(), oofem::LinearStability::restoreContext(), oofem::LIBeam3d2::restoreContext(), oofem::MDMStatus::restoreContext(), oofem::RCM2MaterialStatus::restoreContext(), oofem::AnisotropicDamageMaterialStatus::restoreContext(), oofem::Node::restoreContext(), oofem::FCMMaterialStatus::restoreContext(), and oofem::MDM::unpackAndUpdateUnknowns().
void oofem::FloatMatrix::rotatedWith | ( | const FloatMatrix & | r, |
char | mode = 'n' |
||
) |
Returns the receiver 'a' transformed using give transformation matrix r.
The method performs the operation .
r | Transformation matrix. |
mode | If set to 't' then the transpose of the rotation matrix is used instead. |
Definition at line 1557 of file floatmatrix.C.
References beProductOf(), beProductTOf(), beTProductOf(), and OOFEM_ERROR.
Referenced by oofem::EngngModel::assemble(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::Structural3DElement::computeConstitutiveMatrixAt(), oofem::PlaneStressElement::computeConstitutiveMatrixAt(), oofem::PlaneStrainElement::computeConstitutiveMatrixAt(), oofem::AxisymElement::computeConstitutiveMatrixAt(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::TransportGradientPeriodic::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::StructuralInterfaceElement::computeTraction(), oofem::RankineMat::evaluatePlaneStressStiffMtrx(), oofem::LayeredCrossSection::give2dPlateStiffMtrx(), oofem::WinklerMaterial::give3dBeamSubSoilStiffMtrx(), oofem::OrthotropicLinearElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::CompoDamageMat::give3dMaterialStiffnessMatrix(), oofem::LayeredCrossSection::give3dShellStiffMtrx(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::Element::giveGlobalIPValue(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::LayeredCrossSection::giveStiffnessMatrix_3d(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::DEIDynamic::solveYourselfAt(), oofem::DIIDynamic::timesMtrx(), oofem::TR_SHELL01::ZZErrorEstimatorI_computeLocalStress(), and oofem::TR_SHELL02::ZZErrorEstimatorI_computeLocalStress().
void oofem::FloatMatrix::setColumn | ( | const FloatArray & | src, |
int | c | ||
) |
Sets the values of the matrix in specified column.
If matrix size is zero, the size is adjusted.
src | Array to set at column c. |
c | Column to set. |
Definition at line 648 of file floatmatrix.C.
References oofem::FloatArray::begin(), oofem::FloatArray::end(), giveNumberOfColumns(), giveNumberOfRows(), oofem::FloatArray::giveSize(), OOFEM_ERROR, and values.
Referenced by oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::Shell7Base::computeLambdaGMatrices(), oofem::Shell7Base::computeLambdaNMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::DKTPlate::computeVertexBendingMoments(), oofem::Shell7Base::edgeEvalCovarBaseVectorsAt(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::PrescribedGenStrainShell7::evalCovarBaseVectorsAt(), oofem::Shell7Base::evalCovarBaseVectorsAt(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::Shell7Base::evalInitialCovarBaseVectorsAt(), oofem::PrescribedGenStrainShell7::evalInitialCovarBaseVectorsAt(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncDerivAt(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng_Num(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng_Num(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_Eng_Num(), oofem::StructuralInterfaceMaterial::giveInputRecord(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::FEI3dWedgeLin::giveJacobianMatrixAt(), oofem::FEI3dHexaLin::giveJacobianMatrixAt(), oofem::FEI3dWedgeQuad::giveJacobianMatrixAt(), oofem::FEI3dTetQuad::giveJacobianMatrixAt(), oofem::FEI3dHexaQuad::giveJacobianMatrixAt(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::PLHoopStressCirc::propagateInterface(), oofem::SparseLinearSystemNM::solve(), oofem::InverseIteration::solve(), and oofem::SubspaceIteration::solve().
void oofem::FloatMatrix::setSubMatrix | ( | const FloatMatrix & | src, |
int | sr, | ||
int | sc | ||
) |
Adds the given matrix as sub-matrix to receiver.
The sub-matrix values will be added to receivers corresponding receiver's values at positions (ri...ri+src.nrows, ci....ci+src.ncolumns). The size of receiver will be adjusted, if necessary.
src | Sub-matrix to be inserted. |
sr | Determines the row position (receiver's 1-based index) of first src value to be added. |
sc | Determines the column position (receiver's 1-based index) of first src value to be added. |
Definition at line 557 of file floatmatrix.C.
References giveNumberOfColumns(), giveNumberOfRows(), and OOFEM_ERROR.
Referenced by oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::TransportElement::computeFlow(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeGtoLRotationMatrix(), oofem::Shell7Base::computeLambdaGMatrices(), oofem::Shell7BaseXFEM::computeLambdaGMatricesDis(), and oofem::Shell7Base::giveLayerContributionToSR().
void oofem::FloatMatrix::setTSubMatrix | ( | const FloatMatrix & | src, |
int | sr, | ||
int | sc | ||
) |
Adds the given matrix as sub-matrix to receiver.
The same as setSubMatrix but transposes the source matrix.
src | Sub-matrix to be inserted transposed. |
sr | Determines the row position (receiver's 1-based index) of first src value to be added. |
sc | Determines the column position (receiver's 1-based index) of first src value to be added. |
Definition at line 582 of file floatmatrix.C.
References giveNumberOfColumns(), giveNumberOfRows(), and OOFEM_ERROR.
bool oofem::FloatMatrix::solveForRhs | ( | const FloatArray & | b, |
FloatArray & | answer, | ||
bool | transpose = false |
||
) |
Solves the system of linear equations .
Uses Gaussian elimination with pivoting directly on receiver.
b | RHS of linear system. |
answer | Solution of linear equations. |
transpose | Solves for the transpose of K. |
Definition at line 1112 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), beTranspositionOf(), oofem::IntArray::givePointer(), oofem::FloatArray::givePointer(), givePointer(), oofem::FloatArray::giveSize(), isSquare(), nColumns, nRows, and OOFEM_ERROR.
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::KelvinChainMaterial::computeCharCoefficients(), oofem::MaxwellChainMaterial::computeCharCoefficients(), oofem::TransportGradientNeumann::computeEta(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::LEPlic::doCellDLS(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FCMMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::DruckerPragerPlasticitySM::giveRegAlgorithmicStiffMatrix(), oofem::FEI3dHexaLin::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEInterpolation2d::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::ConcreteDPM2::performRegularReturn(), oofem::ConcreteDPMStatus::restoreConsistency(), oofem::StructuralMaterialEvaluator::solveYourself(), and oofem::FluidMaterialEvaluator::solveYourself().
void oofem::FloatMatrix::solveForRhs | ( | const FloatMatrix & | B, |
FloatMatrix & | answer, | ||
bool | transpose = false |
||
) |
Solves the system of linear equations .
Uses Gaussian elimination with pivoting directly on receiver.
B | RHS of linear system. |
answer | Solution of linear equations, each column corresponding to columns in B. |
transpose | Solves for the transpose of K. |
Definition at line 1204 of file floatmatrix.C.
References at(), beTranspositionOf(), giveNumberOfColumns(), giveNumberOfRows(), oofem::IntArray::givePointer(), givePointer(), isSquare(), nColumns, nRows, and OOFEM_ERROR.
contextIOResultType oofem::FloatMatrix::storeYourself | ( | DataStream & | stream | ) | const |
Definition at line 1852 of file floatmatrix.C.
References oofem::CIO_IOERR, oofem::CIO_OK, nColumns, and nRows.
Referenced by oofem::MDM::packUnknowns(), oofem::EigenValueDynamic::saveContext(), oofem::RCSDEMaterialStatus::saveContext(), oofem::RCSDMaterialStatus::saveContext(), oofem::LinearStability::saveContext(), oofem::LIBeam3d2::saveContext(), oofem::MDMStatus::saveContext(), oofem::RCM2MaterialStatus::saveContext(), oofem::AnisotropicDamageMaterialStatus::saveContext(), oofem::FCMMaterialStatus::saveContext(), and oofem::Node::saveContext().
void oofem::FloatMatrix::subtract | ( | const FloatMatrix & | a | ) |
Subtracts matrix from the receiver.
a | Matrix to be subtracted. |
Definition at line 1084 of file floatmatrix.C.
References givePointer(), isNotEmpty(), nColumns, negated(), nRows, OOFEM_ERROR, operator=(), and values.
Referenced by oofem::Shell7BaseXFEM::computeCohesiveNmatrixAt(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::MisesMat::computeGLPlasticStrain(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::RankineMat::evaluatePlaneStressStiffMtrx(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng(), oofem::TutorialMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), and oofem::FE2FluidMaterial::giveStiffnessMatrices().
void oofem::FloatMatrix::symmetrized | ( | ) |
Initializes the lower half of the receiver according to the upper half.
Definition at line 1576 of file floatmatrix.C.
References at(), nColumns, nRows, and OOFEM_ERROR.
Referenced by oofem::TransportElement::computeBCSubMtrxAt(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::TransportElement::computeCapacitySubMatrix(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::Beam2d::computeConsistentMassMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::MDM::computeDamageTensor(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::SolidShell::computeGeometricStiffness(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::NLStructuralElement::computeInitialStressMatrix(), oofem::TransportElement::computeIntSourceLHSSubMatrix(), oofem::SUPGElement2::computeLSICStabilizationTerm_MB(), oofem::TR21_2D_SUPG::computeLSICTerm(), oofem::Quad10_2D_SUPG::computeLSICTerm(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::Shell7Base::computeMassMatrixNum(), oofem::TR1_2D_SUPG_AXI::computePenetrationWithResistanceBCTerm_MB(), oofem::SUPGElement2::computePressureTerm_MC(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::TR1_2D_SUPG_AXI::computeSlipWithFrictionBCTerm_MB(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::Beam2d::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix_dd(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::TransportGradientDirichlet::computeXi(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::GradDpElement::giveInternalForcesVector(), oofem::CompoDamageMat::giveUnrotated3dMaterialStiffnessMatrix(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::SubspaceIteration::solve(), oofem::Skyline::toFloatMatrix(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().
void oofem::FloatMatrix::times | ( | double | f | ) |
Multiplies receiver by factor f.
f | Factor to multiply by. |
Definition at line 1594 of file floatmatrix.C.
References values.
Referenced by add(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::LinearConstraintBC::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::PrescribedGradientBCWeak::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::ConcreteDPM2::compute3dSecantStiffness(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::CCTPlate::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::Truss2d::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::Lattice2d_mt::computeCapacityMatrix(), oofem::Shell7Base::computeCauchyStressVector(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Lattice2d_mt::computeConductivityMatrix(), oofem::Node2NodeContact::computeContactTangent(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::MDM::computeDamageTensor(), oofem::ConcreteDPM::computeDDRhoDDStress(), oofem::ConcreteDPM2::computeDDRhoDDStress(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::SolidShell::computeEVector(), oofem::PrescribedGradientBCWeak::computeField(), oofem::MisesMat::computeGLPlasticStrain(), oofem::Lattice2d_mt::computeGradientMatrixAt(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::Shell7Base::computeLambdaGMatrices(), oofem::Shell7BaseXFEM::computeLambdaGMatricesDis(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::Shell7Base::computeMassMatrix(), oofem::HTSelement::computeOutwardNormalMatrix(), oofem::PerfectlyPlasticMaterial::computePlasticStiffnessAt(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrxFromQuaternion(), oofem::HTSelement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::TrPlanestressRotAllman::computeStiffnessMatrixZeroEnergyStabilization(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::ContactElement::ContactElement(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::FEI3dTetLin::evaldNdx(), oofem::RankineMat::evaluatePlaneStressStiffMtrx(), oofem::IDGMaterial::give1dGprime(), oofem::MisesMatGrad::give1dGprime(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng_Num(), oofem::IDGMaterial::give1dStressStiffMtrx(), oofem::MisesMat::give1dStressStiffMtrx(), oofem::IsotropicLinearElasticMaterial::give1dStressStiffMtrx(), oofem::RankineMat::give1dStressStiffMtrx(), oofem::RheoChainMaterial::give1dStressStiffMtrx(), oofem::IsotropicDamageMaterial::give1dStressStiffMtrx(), oofem::MPSDamMaterial::give1dStressStiffMtrx(), oofem::ConcreteDPM2::give1dStressStiffMtrx(), oofem::RheoChainMaterial::give2dLatticeStiffMtrx(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng_Num(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::MisesMatGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::RheoChainMaterial::give3dLatticeStiffMtrx(), oofem::OrthotropicLinearElasticMaterial::give3dLocalMaterialStiffnessMatrix(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::TutorialMaterial::give3dMaterialStiffnessMatrix(), oofem::AnisotropicLinearElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::MisesMatGrad::give3dMaterialStiffnessMatrix(), oofem::M1Material::give3dMaterialStiffnessMatrix(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::MisesMat::give3dMaterialStiffnessMatrix(), oofem::TrabBoneNL3D::give3dMaterialStiffnessMatrix(), oofem::IsotropicLinearElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::IsotropicDamageMaterial::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::RheoChainMaterial::give3dMaterialStiffnessMatrix(), oofem::MPSDamMaterial::give3dMaterialStiffnessMatrix(), oofem::DustMaterial::give3dMaterialStiffnessMatrix(), oofem::ConcreteDPM::give3dMaterialStiffnessMatrix(), oofem::IntMatElastic::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_dTdj_Num(), oofem::IsoInterfaceDamageMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial_2::give3dStiffnessMatrix_Eng(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_Eng_Num(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TrPlaneStress2d::giveCharacteristicSize(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::RCSDEMaterial::giveEffectiveMaterialStiffnessMatrix(), oofem::RCSDMaterial::giveEffectiveMaterialStiffnessMatrix(), oofem::IsoInterfaceDamageMaterial::giveEngTraction_3d(), oofem::IsoInterfaceDamageMaterial_2::giveEngTraction_3d(), oofem::StructuralPythonMaterial::giveFirstPKStressVector_3d(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::StructuralMaterial::giveFirstPKStressVector_3d(), oofem::IntMatCoulombContact::giveGeneralStiffnessMatrix(), oofem::StructuralInterfaceMaterial::giveInputRecord(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::IDGMaterial::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::IDGMaterial::givePlaneStrainStiffMtrx(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::IsotropicLinearElasticMaterial::givePlaneStrainStiffMtrx(), oofem::RheoChainMaterial::givePlaneStrainStiffMtrx(), oofem::IsotropicDamageMaterial::givePlaneStrainStiffMtrx(), oofem::MPSDamMaterial::givePlaneStrainStiffMtrx(), oofem::IDGMaterial::givePlaneStressGprime(), oofem::RankineMatGrad::givePlaneStressGprime(), oofem::IDGMaterial::givePlaneStressStiffMtrx(), oofem::RankineMatNl::givePlaneStressStiffMtrx(), oofem::IsotropicLinearElasticMaterial::givePlaneStressStiffMtrx(), oofem::RheoChainMaterial::givePlaneStressStiffMtrx(), oofem::IsotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::MPSDamMaterial::givePlaneStressStiffMtrx(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::IsotropicDamageMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::IDGMaterial::giveRealStressVectorGrad(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::LayeredCrossSection::giveStiffnessMatrix_PlaneStress(), oofem::DruckerPragerPlasticitySM::giveVertexAlgorithmicStiffMatrix(), oofem::MidpointLhsAssembler::matrixFromElement(), oofem::SUPGTangentAssembler::matrixFromElement(), oofem::EffectiveTangentAssembler::matrixFromElement(), oofem::EffectiveTangentAssembler::matrixFromSurfaceLoad(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha2(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::PrescribedGradientBCNeumann::scale(), oofem::MixedGradientPressureWeakPeriodic::scale(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::tet21ghostsolid::tet21ghostsolid(), and oofem::SUPGInternalForceAssembler::vectorFromElement().
void oofem::FloatMatrix::writeCSV | ( | const std::string & | name | ) | const |
Writes receiver as CSV (comma seperated values)
name | Filename |
Definition at line 1543 of file floatmatrix.C.
void oofem::FloatMatrix::zero | ( | ) |
Zeroes all coefficient of receiver.
Definition at line 1326 of file floatmatrix.C.
References values.
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::AnisotropicDamageMaterialStatus::AnisotropicDamageMaterialStatus(), oofem::PrescribedGradientBCWeak::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleExtraDisplock(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::Beam3d::B3SSMI_getUnknownsGtoLRotationMatrix(), beInverseOf(), beUnitMatrix(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MC(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::ConcreteDPM::computeAMatrix(), oofem::HTSelement::computeAMatrixAt(), oofem::TransportElement::computeBCMtrxAt(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::Quad1PlaneStrain::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::Tet1_3D_SUPG::computeBMatrix(), oofem::PFEMElement2d::computeBMatrix(), oofem::TR21_2D_SUPG::computeBMatrix(), oofem::Quad10_2D_SUPG::computeBMatrix(), oofem::LSpaceBB::computeBmatrixAt(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::TrPlanestressRotAllman::computeBmatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::Quad2PlateSubSoil::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::CCTPlate::computeBmatrixAt(), oofem::QDKTPlate::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElem2dQuad::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::Quad1PlateSubSoil::computeBmatrixAt(), oofem::DKTPlate::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::Tria1PlateSubSoil::computeBmatrixAt(), oofem::LIBeam2d::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::PlaneStress2d::computeBmatrixAt(), oofem::LIBeam2dNL::computeBmatrixAt(), oofem::LIBeam3d::computeBmatrixAt(), oofem::Quad1Mindlin::computeBmatrixAt(), oofem::tet21ghostsolid::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::MITC4Shell::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::computeBmatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::Lattice2d_mt::computeCapacityMatrix(), oofem::TransportElement::computeCapacityMatrix(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::Lattice2d_mt::computeConductivityMatrix(), oofem::TransportElement::computeConductivityMatrix(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::Beam2d::computeConsistentMassMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::AbaqusUserElement::computeConsistentMassMatrix(), oofem::TR1_2D_CBS::computeConsistentMassMtrx(), oofem::Node2NodeContact::computeContactTangent(), oofem::Node2NodeContactL::computeContactTangent(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::ConcreteDPM::computeDDRhoDDStress(), oofem::ConcreteDPM2::computeDDRhoDDStress(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::PlasticMaterial::computeDiagModuli(), oofem::MPlasticMaterial::computeDiagModuli(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MC(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::Tet1_3D_SUPG::computeDivTauMatrix(), oofem::TR21_2D_SUPG::computeDivTauMatrix(), oofem::Quad10_2D_SUPG::computeDivTauMatrix(), oofem::Tet1_3D_SUPG::computeDivUMatrix(), oofem::TR21_2D_SUPG::computeDivUMatrix(), oofem::Quad10_2D_SUPG::computeDivUMatrix(), oofem::Element::computeDofTransformationMatrix(), oofem::SolidShell::computeEASBmatrixAt(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::HTSelement::computeFMatrixAt(), oofem::SolidShell::computeGeometricStiffness(), oofem::IntElLine1PF::computeGMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Lattice2d_mt::computeGradientMatrixAt(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::LIBeam2dNL::computeGtoLRotationMatrix(), oofem::LIBeam2d::computeGtoLRotationMatrix(), oofem::LIBeam3d::computeGtoLRotationMatrix(), oofem::LIBeam3d2::computeGtoLRotationMatrix(), oofem::RerShell::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::TrPlanestressRotAllman3d::computeGtoLRotationMatrix(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::Lattice2d::computeGtoLRotationMatrix(), oofem::Beam2d::computeGtoLRotationMatrix(), oofem::Beam3d::computeGtoLRotationMatrix(), oofem::J2MPlasticMaterial::computeHardeningReducedModuli(), oofem::J2plasticMaterial::computeHardeningReducedModuli(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::TransportElement::computeIntSourceLHSMatrix(), oofem::Node::computeL2GTransformation(), oofem::Shell7Base::computeLambdaGMatrices(), oofem::Shell7BaseXFEM::computeLambdaGMatricesDis(), oofem::Shell7Base::computeLambdaNMatrix(), oofem::Shell7BaseXFEM::computeLambdaNMatrixDis(), oofem::TR1_2D_SUPG_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeLinearAdvectionTerm_MC(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::TrPlaneStrRot3d::computeLoadGToLRotationMtrx(), oofem::TrPlanestressRotAllman3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadGToLRotationMtrx(), oofem::CCTPlate3d::computeLoadGToLRotationMtrx(), oofem::LinQuad3DPlaneStress::computeLoadGToLRotationMtrx(), oofem::LIBeam2d::computeLoadGToLRotationMtrx(), oofem::LIBeam2dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d::computeLoadGToLRotationMtrx(), oofem::MITC4Shell::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL2::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d2::computeLoadGToLRotationMtrx(), oofem::Beam3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadLEToLRotationMatrix(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::CCTPlate::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::Quad1Mindlin::computeLoadLEToLRotationMatrix(), oofem::Truss2d::computeLoadLEToLRotationMatrix(), oofem::QDKTPlate::computeLoadLEToLRotationMatrix(), oofem::DKTPlate::computeLoadLEToLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLoadLEToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::TR1_2D_SUPG_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2::computeLSICStabilizationTerm_MB(), oofem::LIBeam2dNL::computeLumpedMassMatrix(), oofem::LIBeam2d::computeLumpedMassMatrix(), oofem::LIBeam3d::computeLumpedMassMatrix(), oofem::InterfaceElem1d::computeLumpedMassMatrix(), oofem::LumpedMassElement::computeLumpedMassMatrix(), oofem::Truss3d::computeLumpedMassMatrix(), oofem::Truss1d::computeLumpedMassMatrix(), oofem::LTRSpace::computeLumpedMassMatrix(), oofem::RerShell::computeLumpedMassMatrix(), oofem::Truss2d::computeLumpedMassMatrix(), oofem::LIBeam3dNL::computeLumpedMassMatrix(), oofem::LIBeam3dNL2::computeLumpedMassMatrix(), oofem::NodalSpringElement::computeLumpedMassMatrix(), oofem::LIBeam3d2::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::Quad1Mindlin::computeLumpedMassMatrix(), oofem::Quad1MindlinShell3D::computeLumpedMassMatrix(), oofem::CCTPlate::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::DKTPlate::computeLumpedMassMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::Shell7Base::computeMassMatrixNum(), oofem::LIBeam2dNL::computeNLBMatrixAt(), oofem::TrPlaneStrRot::computeNmatrixAt(), oofem::TrPlanestressRotAllman::computeNmatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::CCTPlate::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::LIBeam2d::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::LIBeam2dNL::computeNmatrixAt(), oofem::LIBeam3d::computeNmatrixAt(), oofem::MITC4Shell::computeNmatrixAt(), oofem::Truss2d::computeNmatrixAt(), oofem::IntElPoint::computeNmatrixAt(), oofem::LIBeam3dNL2::computeNmatrixAt(), oofem::LIBeam3dNL::computeNmatrixAt(), oofem::RerShell::computeNmatrixAt(), oofem::LIBeam3d2::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::Lattice2d_mt::computeNSubMatrixAt(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::WeakPeriodicBoundaryCondition::computeOrthogonalBasis(), oofem::TR1_2D_SUPG::computeOutFlowBCTerm_MB(), oofem::HTSelement::computeOutwardNormalMatrix(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::TR1_2D_SUPG::computePenetrationWithResistanceBCTerm_MB(), oofem::AnisotropicDamageMaterial::computePlaneStressStrain(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG::computePressureTerm_MB(), oofem::TR1_2D_SUPG2::computePressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG2::computePressureTerm_MC(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSKGradientMatrix(), oofem::Masonry02::computeReducedSKGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::Masonry02::computeReducedSSGradientMatrix(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::TR1_2D_SUPG::computeSlipWithFrictionBCTerm_MB(), oofem::GradDpElement::computeStiffnessMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::MITC4Shell::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::Lattice2d::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::TrPlaneStrRot3d::computeSurfaceNMatrixAt(), oofem::CCTPlate3d::computeSurfaceNMatrixAt(), oofem::DKTPlate3d::computeSurfaceNMatrixAt(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::ElementSide::computeTransformation(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::HTSelement::computeUgammaMatrixAt(), oofem::LIBeam3dNL::computeXMtrx(), oofem::LIBeam3dNL2::computeXMtrx(), oofem::TrabBone3D::constructAnisoStiffnessTensor(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::TrabBone3D::constructNormAdjustTensor(), oofem::ContactElement::ContactElement(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::LEPlic::doCellDLS(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7Base::edgeComputeNmatrixAt(), oofem::FEI3dLineLin::evald2Ndx2(), oofem::FEI1dHermite::evald2Ndx2(), oofem::NURBSInterpolation::evaldNdx(), oofem::FEI2dTrConst::evaldNdx(), oofem::FEI1dHermite::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::TSplineInterpolation::evaldNdx(), oofem::BSplineInterpolation::evaldNdx(), oofem::PrescribedGenStrainShell7::evaluateHigherOrderContribution(), oofem::RankineMat::evaluatePlaneStressStiffMtrx(), oofem::VTKExportModule::exportCellVars(), oofem::VTKExportModule::exportIntVarAs(), oofem::FCMMaterialStatus::FCMMaterialStatus(), oofem::MDM::formTransformationMatrix(), oofem::IDGMaterial::give1dGprime(), oofem::MisesMatGrad::give1dGprime(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng_Num(), oofem::SteelRelaxMat::give1dStressStiffMtrx(), oofem::SimpleCrossSection::give2dBeamStiffMtrx(), oofem::LayeredCrossSection::give2dBeamStiffMtrx(), oofem::SimpleCrossSection::give2dPlateStiffMtrx(), oofem::LayeredCrossSection::give2dPlateStiffMtrx(), oofem::WinklerPasternakMaterial::give2dPlateSubSoilStiffMtrx(), oofem::WinklerMaterial::give2dPlateSubSoilStiffMtrx(), oofem::IntMatIsoDamage::give2dStiffnessMatrix_Eng(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng_Num(), oofem::StructuralMaterial::give2DStrainVectorTranformationMtrx(), oofem::SimpleCrossSection::give3dBeamStiffMtrx(), oofem::FiberedCrossSection::give3dBeamStiffMtrx(), oofem::LayeredCrossSection::give3dDegeneratedShellStiffMtrx(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::MisesMatGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::OrthotropicLinearElasticMaterial::give3dLocalMaterialStiffnessMatrix(), oofem::SimpleVitrificationMaterial::give3dMaterialStiffnessMatrix(), oofem::M1Material::give3dMaterialStiffnessMatrix(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::IsotropicLinearElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::MicroplaneMaterial::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::AnisotropicDamageMaterial::give3dMaterialStiffnessMatrix(), oofem::SimpleCrossSection::give3dShellStiffMtrx(), oofem::LayeredCrossSection::give3dShellStiffMtrx(), oofem::IntMatDummyCZ::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZElastic::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::CohesiveInterfaceMaterial::give3dStiffnessMatrix_Eng(), oofem::IntMatPhaseField::give3dStiffnessMatrix_Eng(), oofem::ExpCZMaterial::give3dStiffnessMatrix_Eng(), oofem::BondCEBMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial_2::give3dStiffnessMatrix_Eng(), oofem::IntMatIsoDamage::give3dStiffnessMatrix_Eng(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_Eng_Num(), oofem::Shell7Base::giveAxialMatrix(), oofem::SUPGElement2::giveCharacteristicMatrix(), oofem::PFEMElement::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TR_SHELL02::giveCharacteristicMatrix(), oofem::TR_SHELL01::giveCharacteristicMatrix(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::MITC4Shell::giveCharacteristicTensor(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::RCM2Material::giveCrackedStiffnessMatrix(), oofem::TutorialMaterial::giveDeviatoricProjectionMatrix(), oofem::NewtonianFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::BinghamFluidMaterial2::giveDeviatoricStiffnessMatrix(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::LatticeDamage2d::giveElasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::StructuralMaterial::giveFullSymMatrixForm(), oofem::StructuralInterfaceMaterial::giveInputRecord(), oofem::GradDpElement::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::IDGMaterial::giveInternalLength(), oofem::IDGMaterial::giveInternalLengthDerivative(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::FEInterpolation2d::giveJacobianMatrixAt(), oofem::TSplineInterpolation::giveJacobianMatrixAt(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Lattice2d::giveLocalCoordinateSystem(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::Truss2d::giveLocalCoordinateSystem(), oofem::Beam2d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::FEI3dTrQuad::giveLocalNodeCoords(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::IsotropicLinearElasticMaterial::givePlaneStrainStiffMtrx(), oofem::StructuralMaterial::givePlaneStrainStiffMtrx(), oofem::RankineMatGrad::givePlaneStressGprime(), oofem::IDGMaterial::givePlaneStressKappaMatrix(), oofem::RankineMatGrad::givePlaneStressKappaMatrix(), oofem::IsotropicLinearElasticMaterial::givePlaneStressStiffMtrx(), oofem::AnisotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::StructuralMaterial::givePlaneStressVectorTranformationMtrx(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FCMMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::DruckerPragerPlasticitySM::giveRegAlgorithmicStiffMatrix(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::LatticeDamage2d::giveSecantStiffnessMatrix(), oofem::LayeredCrossSection::giveStiffnessMatrix_PlaneStress(), oofem::StructuralMaterial::giveStrainVectorTranformationMtrx(), oofem::StructuralMaterial::giveStressVectorTranformationMtrx(), oofem::IntMatPhaseField::giveTangents(), oofem::Shell7Base::giveTractionBC(), oofem::CompoDamageMat::giveUnrotated3dMaterialStiffnessMatrix(), oofem::DruckerPragerPlasticitySM::giveVertexAlgorithmicStiffMatrix(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::IntMatBilinearCZJanssonStatus::initTempStatus(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::SUPGTangentAssembler::matrixFromElement(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalRecoveryMI_computeNValProduct(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::SolidShell::postInitialize(), oofem::Skyline::rbmodes(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SubspaceIteration::solve(), oofem::FETISolver::solve(), oofem::EigenValueDynamic::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::tet21ghostsolid::tet21ghostsolid(), oofem::SkylineUnsym::toFloatMatrix(), oofem::Skyline::toFloatMatrix(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().
|
friend |
Definition at line 2098 of file floatmatrix.C.
|
protected |
Number of columns.
Definition at line 100 of file floatmatrix.h.
Referenced by add(), addProductOf(), addTProductOf(), beInverseOf(), beProductOf(), beProductTOf(), beSubMatrixOf(), beTProductOf(), beUnitMatrix(), changeComponentOrder(), checkBounds(), computeNorm(), computeReciprocalCondition(), FloatMatrix(), giveDeterminant(), givePackSize(), giveTrace(), hardResize(), initFromVector(), oofem::operator<<(), operator=(), plusDyadSymmUpper(), plusDyadUnsym(), plusProductSymmUpper(), plusProductUnsym(), printYourself(), printYourselfToFile(), pY(), resize(), resizeWithData(), restoreYourself(), solveForRhs(), storeYourself(), subtract(), symmetrized(), and writeCSV().
|
protected |
Number of rows.
Definition at line 98 of file floatmatrix.h.
Referenced by add(), addProductOf(), addTProductOf(), beInverseOf(), beMatrixFormOfStress(), beProductOf(), beProductTOf(), beSubMatrixOf(), beTProductOf(), beUnitMatrix(), changeComponentOrder(), checkBounds(), computeNorm(), computeReciprocalCondition(), FloatMatrix(), giveDeterminant(), givePackSize(), giveTrace(), hardResize(), initFromVector(), isFinite(), oofem::operator<<(), operator=(), plusDyadSymmUpper(), plusDyadUnsym(), plusProductSymmUpper(), plusProductUnsym(), printYourself(), printYourselfToFile(), pY(), resize(), resizeWithData(), restoreYourself(), solveForRhs(), storeYourself(), subtract(), symmetrized(), and writeCSV().
|
protected |
Values of matrix stored column wise.
Definition at line 102 of file floatmatrix.h.
Referenced by add(), bePinvID(), computeFrobeniusNorm(), copyColumn(), FloatMatrix(), giveDeterminant(), giveTrace(), hardResize(), initFromVector(), isFinite(), negated(), operator=(), plusDyadSymmUpper(), plusDyadUnsym(), plusProductSymmUpper(), plusProductUnsym(), resize(), resizeWithData(), restoreYourself(), setColumn(), subtract(), times(), and zero().