|
OOFEM 3.0
|
#include <floatmatrix.h>
Public Types | |
| typedef double | Scalar |
Public Member Functions | |
| FloatMatrix (std::size_t n, std::size_t m) | |
| FloatMatrix () | |
| Creates zero sized matrix. | |
| FloatMatrix (const FloatMatrix &mat) | |
| Copy constructor. | |
| FloatMatrix (FloatMatrix &&mat) noexcept | |
| Copy constructor. | |
| FloatMatrix & | operator= (const FloatMatrix &mat) |
| Assignment operator, adjusts size of the receiver if necessary. | |
| FloatMatrix & | operator= (FloatMatrix &&mat) noexcept |
| int | rows () const |
| int | cols () const |
| double & | operator() (std::size_t i, std::size_t j) |
| double | operator() (std::size_t i, std::size_t j) const |
| const double * | data () const |
| double * | data () |
| template<std::size_t N, std::size_t M> | |
| void | assignFloatMatrixF (const FloatMatrixF< N, M > &mat) |
| void | _resize_internal (int nr, int nc) |
| FloatMatrix (std ::initializer_list< std ::initializer_list< double > > ini) | |
| FloatMatrix & | operator= (std ::initializer_list< std ::initializer_list< double > >mat) |
| template<std::size_t M, std::size_t N> | |
| FloatMatrix (const FloatMatrixF< N, M > &src) | |
| template<std::size_t N, std::size_t M> | |
| FloatMatrix & | operator= (const FloatMatrixF< N, M > &mat) |
| void | checkBounds (Index i, Index j) const |
| int | giveNumberOfRows () const |
| Returns number of rows of receiver. | |
| int | giveNumberOfColumns () const |
| Returns number of columns of receiver. | |
| bool | isSquare () const |
| Returns nonzero if receiver is square matrix. | |
| bool | isNotEmpty () const |
| Tests for empty matrix. | |
| bool | isAllFinite () const |
| Returns true if no element is NAN or infinite. | |
| double | at (std::size_t i, std::size_t j) const |
| double & | at (std::size_t i, std::size_t j) |
| void | assemble (const FloatMatrix &src, const IntArray &loc) |
| void | assemble (const FloatMatrix &src, const IntArray &rowind, const IntArray &colind) |
| void | assembleT (const FloatMatrix &src, const IntArray &rowind, const IntArray &colind) |
| double | computeFrobeniusNorm () const |
| double | computeNorm (char p) const |
| double | computeReciprocalCondition (char p='1') const |
| void | beDiagonal (const FloatArray &diag) |
| double | giveTrace () const |
| double | giveDeterminant () const |
| void | zero () |
| Zeroes all coefficient of receiver. | |
| void | beUnitMatrix () |
| Sets receiver to unity matrix. | |
| void | bePinvID () |
| Sets receiver to the inverse of scaling matrix P multiplied by the deviatoric projector ID. | |
| void | beTranspositionOf (const FloatMatrix &src) |
| void | beProductOf (const FloatMatrix &a, const FloatMatrix &b) |
| void | addProductOf (const FloatMatrix &a, const FloatMatrix &b) |
| void | addTProductOf (const FloatMatrix &a, const FloatMatrix &b) |
| void | beTProductOf (const FloatMatrix &a, const FloatMatrix &b) |
| void | beProductTOf (const FloatMatrix &a, const FloatMatrix &b) |
| void | beDyadicProductOf (const FloatArray &vec1, const FloatArray &vec2) |
| void | beNMatrixOf (const FloatArray &n, int nsd) |
| void | beLocalCoordSys (const FloatArray &normal) |
| void | setSubMatrix (const FloatMatrix &src, int sr, int sc) |
| void | beSubMatrixOf (const FloatMatrix &src, Index topRow, Index bottomRow, Index topCol, Index bottomCol) |
| void | beSubMatrixOf (const FloatMatrix &src, const IntArray &indxRow, const IntArray &indxCol) |
| void | addSubVectorRow (const FloatArray &src, int sr, int sc) |
| void | addSubVectorCol (const FloatArray &src, int sr, int sc) |
| void | copySubVectorRow (const FloatArray &src, int sr, int sc) |
| void | setColumn (const FloatArray &src, int c) |
| void | copyColumn (FloatArray &dest, int c) const |
| bool | beInverseOf (const FloatMatrix &src) |
| bool | solveForRhs (const FloatArray &b, FloatArray &answer, bool transpose=false) |
| bool | solveForRhs (const FloatMatrix &B, FloatMatrix &answer, bool transpose=false) |
| void | plusProductSymmUpper (const FloatMatrix &a, const FloatMatrix &b, double dV) |
| void | plusDyadSymmUpper (const FloatArray &a, double dV) |
| void | plusProductUnsym (const FloatMatrix &a, const FloatMatrix &b, double dV) |
| void | plusDyadUnsym (const FloatArray &a, const FloatArray &b, double dV) |
| void | plus_Nt_a_otimes_b_B (const FloatMatrix &N, const FloatArray &a, const FloatArray &b, const FloatMatrix &B, double dV=1) |
| void | add (const FloatMatrix &a) |
| void | add (double s, const FloatMatrix &a) |
| void | subtract (const FloatMatrix &a) |
| void | times (double f) |
| void | negated () |
| void | symmetrized () |
| void | rotatedWith (const FloatMatrix &r, char mode='n') |
| void | resize (Index rows, Index cols) |
| void | resizeWithData (Index, Index) |
| *Sets size of receiver to be an empty matrix It will have zero rows and zero columns size void | clear () |
| bool | jaco_ (FloatArray &eval, FloatMatrix &v, int nf) |
| *Prints matrix to stdout Useful for debugging void | printYourself () const |
| void | printYourself (const std::string &name) const |
| void | printYourselfToFile (const std::string filename, const bool showDimensions=true) const |
| *Higher accuracy than printYourself void | pY () const |
| void | writeCSV (const std ::string &name) const |
| const double * | givePointer () const |
| double * | givePointer () |
| void | beMatrixFormOfStress (const FloatArray &aArray) |
| void | beMatrixForm (const FloatArray &aArray) |
| void | changeComponentOrder () |
| contextIOResultType | storeYourself (DataStream &stream) const |
| contextIOResultType | restoreYourself (DataStream &stream) |
| int | givePackSize (DataStream &buff) const |
Static Public Member Functions | |
| static FloatMatrix | fromIniList (std ::initializer_list< std ::initializer_list< double > >) |
| static FloatMatrix | fromCols (std ::initializer_list< FloatArray >mat) |
| static FloatMatrix | fromArray (const FloatArray &vector, bool transpose=false) |
Static Public Attributes | |
| static constexpr int | Dim = 2 |
Protected Attributes | |
| std::size_t | nRows |
| Number of rows. | |
| std::size_t | nColumns |
| Number of columns. | |
| std ::vector< double > | values |
| Values of matrix stored column wise. | |
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 83 of file floatmatrix.h.
| typedef double oofem::FloatMatrix::Scalar |
Definition at line 103 of file floatmatrix.h.
|
inline |
Creates matrix of given size.
| n | Number of rows. |
| m | Requested number of columns. |
Definition at line 109 of file floatmatrix.h.
References nColumns, nRows, and values.
Referenced by add(), add(), addProductOf(), addTProductOf(), assemble(), assemble(), assembleT(), beInverseOf(), bePinvID(), beProductOf(), beProductTOf(), beSubMatrixOf(), beSubMatrixOf(), beTProductOf(), beTranspositionOf(), changeComponentOrder(), computeReciprocalCondition(), FloatMatrix(), FloatMatrix(), fromArray(), fromCols(), fromIniList(), giveDeterminant(), jaco_(), operator<<, operator=(), operator=(), operator=(), operator=(), plus_Nt_a_otimes_b_B(), plusProductSymmUpper(), plusProductUnsym(), resizeWithData(), rotatedWith(), setSubMatrix(), solveForRhs(), solveForRhs(), and subtract().
|
inline |
Creates zero sized matrix.
Definition at line 111 of file floatmatrix.h.
|
inline |
Copy constructor.
Definition at line 113 of file floatmatrix.h.
References FloatMatrix(), nColumns, nRows, and values.
|
inlinenoexcept |
Copy constructor.
Definition at line 115 of file floatmatrix.h.
References FloatMatrix(), nColumns, nRows, and values.
|
inline |
Definition at line 168 of file floatmatrix.h.
References fromIniList().
|
inline |
Definition at line 173 of file floatmatrix.h.
References assignFloatMatrixF().
| void oofem::FloatMatrix::_resize_internal | ( | int | nr, |
| int | nc ) |
Definition at line 68 of file floatmatrix.C.
References nColumns, nRows, and values.
Referenced by beDyadicProductOf(), beInverseOf(), beProductOf(), beProductTOf(), beTProductOf(), beTranspositionOf(), and fromIniList().
| 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 962 of file floatmatrix.C.
References _LOOP_MATRIX, cols(), FloatMatrix(), givePointer(), isNotEmpty(), OOFEM_ERROR, and rows().
Referenced by oofem::Truss3dnl::_computeBmatrixAt(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DGProblem::assembleDirichletBcRhsVector(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::SUPGElement::computeBCLhsPressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MC(), oofem::SUPGElement::computeBCLhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCLhsTerm_MB(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), 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::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::Beam3d::computeStiffnessMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::Shell7Base::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::TrPlanestressRotAllman::computeStiffnessMatrix(), oofem::Truss3dnl2::computeStiffnessMatrix(), oofem::Truss3dnl::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::PrescribedDispSlipBCNeumannRC::computeWeightMatrix(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::Shell7Base::giveRecoveredTransverseInterfaceStress(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::MPElement::integrateEdgeTerm_dw(), oofem::MPElement::integrateSurfaceTerm_dw(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressSteel(), oofem::TransverseReinfConstraint::integrateTangentOnConcrete(), oofem::TransverseReinfConstraint::integrateTangentOnSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), oofem::MPElement::integrateTerm_dw(), oofem::TR21_2D_SUPG::LS_PCS_computedN(), oofem::EffectiveTangentAssembler::matrixFromElement(), oofem::MidpointLhsAssembler::matrixFromElement(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha2(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::operator+(), oofem::operator+=(), oofem::Shell7Base::recoverShearStress(), oofem::Shell7BaseXFEM::recoverShearStress(), and oofem::ScalarAdvectionRhsAssembler::vectorFromElement().
| 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 991 of file floatmatrix.C.
References _LOOP_MATRIX, cols(), FloatMatrix(), givePointer(), isNotEmpty(), OOFEM_ERROR, rows(), and times().
| void oofem::FloatMatrix::addProductOf | ( | const FloatMatrix & | a, |
| const FloatMatrix & | b ) |
Adds to the receiver product of \( a \cdot b \) .
Definition at line 464 of file floatmatrix.C.
References at(), cols(), FloatMatrix(), givePointer(), OOFEM_ERROR, and rows().
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 622 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::FloatArray::giveSize(), oofem::max(), and resizeWithData().
Referenced by 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 600 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::FloatArray::giveSize(), oofem::max(), and resizeWithData().
Referenced by 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 \( a^{\mathrm{T}} \cdot b \) .
Definition at line 499 of file floatmatrix.C.
References at(), cols(), FloatMatrix(), givePointer(), OOFEM_ERROR, and rows().
| 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 181 of file floatmatrix.C.
References at(), oofem::IntArray::at(), FloatMatrix(), isSquare(), OOFEM_ERROR, rows(), and oofem::IntArray::size().
Referenced by oofem::MPElement::assembleTermContribution(), 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::Shell7Base::computeMassMatrixNum(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::BaseMixedPressureElement::computeStiffnessMatrix(), oofem::GradDpElement::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix(), oofem::MITC4Shell::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix(), oofem::QPlaneStress2dSlip::computeStiffnessMatrix(), oofem::QTrPlaneStress2dSlip::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::BondLink3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundaryBeam::computeTransformationMatrix(), oofem::LIBeam3dBoundaryMembrane::computeTransformationMatrix(), oofem::LIBeam3dBoundaryPlate::computeTransformationMatrix(), oofem::LIBeam3dBoundaryTruss::computeTransformationMatrix(), oofem::LIBeam3dBoundaryVoigt::computeTransformationMatrix(), oofem::LTRSpaceBoundary::computeTransformationMatrix(), oofem::LTRSpaceBoundaryBeam::computeTransformationMatrix(), oofem::LTRSpaceBoundaryMembrane::computeTransformationMatrix(), oofem::LTRSpaceBoundaryPlate::computeTransformationMatrix(), oofem::LTRSpaceBoundaryTruss::computeTransformationMatrix(), oofem::LTRSpaceBoundaryVoigt::computeTransformationMatrix(), oofem::TransportGradientDirichlet::computeXi(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::LayeredCrossSection::give3dShellRotStiffMtrx(), oofem::SimpleCrossSection::give3dShellRotStiffMtrx(), oofem::PFEMElement::giveCharacteristicMatrix(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::SUPGElement2::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TR_SHELL01::giveCharacteristicMatrix(), oofem::TR_SHELL02::giveCharacteristicMatrix(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::StructuralMaterial::giveFullSymMatrixForm(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::ScalarAdvectionLhsAssembler::matrixFromElement(), oofem::SUPGTangentAssembler::matrixFromElement(), oofem::TMLhsAssembler::matrixFromElement(), oofem::UPLhsAssembler::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 222 of file floatmatrix.C.
References at(), oofem::IntArray::at(), FloatMatrix(), giveNumberOfColumns(), giveNumberOfRows(), oofem::IntArray::giveSize(), and OOFEM_ERROR.
| void oofem::FloatMatrix::assembleT | ( | const FloatMatrix & | src, |
| const IntArray & | rowind, | ||
| const IntArray & | colind ) |
Assembles the transposed 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 255 of file floatmatrix.C.
References at(), oofem::IntArray::at(), FloatMatrix(), giveNumberOfColumns(), giveNumberOfRows(), oofem::IntArray::giveSize(), and OOFEM_ERROR.
Referenced by oofem::MPElement::assembleTermContributionT().
|
inline |
Definition at line 162 of file floatmatrix.h.
References cols(), N, resize(), and rows().
Referenced by FloatMatrix(), and operator=().
|
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 231 of file floatmatrix.h.
|
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 221 of file floatmatrix.h.
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), addProductOf(), addSubVectorCol(), addSubVectorRow(), addTProductOf(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::MDM::applyDamageToStiffness(), oofem::DynCompCol::assemble(), oofem::DynCompCol::assemble(), oofem::DynCompRow::assemble(), assemble(), assemble(), oofem::LinearConstraintBC::assemble(), oofem::Skyline::assemble(), oofem::Skyline::assemble(), oofem::SkylineUnsym::assemble(), oofem::SkylineUnsym::assemble(), oofem::SpoolesSparseMtrx::assemble(), oofem::SpoolesSparseMtrx::assemble(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::PrescribedGradientBCWeak::assembleExtraDisplock(), oofem::TransportElement::assembleLocalContribution(), assembleT(), oofem::Beam3d::B3SSMI_getUnknownsGtoLRotationMatrix(), beDyadicProductOf(), beInverseOf(), beLocalCoordSys(), beMatrixForm(), beMatrixFormOfStress(), oofem::FloatArray::beProductOf(), beProductOf(), beProductTOf(), oofem::FloatArray::beRowOf(), beSubMatrixOf(), beSubMatrixOf(), oofem::FloatArray::beSymVectorForm(), oofem::FloatArray::beSymVectorFormOfStrain(), oofem::FloatArray::beTProductOf(), beTProductOf(), beTranspositionOf(), beUnitMatrix(), oofem::FloatArray::beVectorForm(), changeComponentOrder(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::AnisotropicDamageMaterial::checkSymmetry(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::Tr2Shell7::compareMatrices(), oofem::Tensor2_3d::compute_dCm_dC_fromEigs(), oofem::FEContactPoint::compute_dNdxi_matrix(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::TR1_2D_SUPG2::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MC(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::LTRSpaceBoundary::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::PlaneStress2d::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::Quad1PlaneStrain::computeBHmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PFEMElement2d::computeBMatrix(), oofem::Quad10_2D_SUPG::computeBMatrix(), oofem::Tet1_3D_SUPG::computeBMatrix(), oofem::TR21_2D_SUPG::computeBMatrix(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::computeBmatrixAt(), oofem::BondLink3d::computeBmatrixAt(), oofem::CCTPlate::computeBmatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::DKTPlate::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElem2dQuad::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::Lattice2dBoundary::computeBmatrixAt(), oofem::Lattice3d::computeBmatrixAt(), oofem::Lattice3dBoundary::computeBmatrixAt(), oofem::Lattice3dBoundaryTruss::computeBmatrixAt(), oofem::LatticeLink3d::computeBmatrixAt(), oofem::LIBeam2d::computeBmatrixAt(), oofem::LIBeam2dNL::computeBmatrixAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::LIBeam3d::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::LSpace::computeBmatrixAt(), oofem::LSpaceBB::computeBmatrixAt(), oofem::LTRSpaceBoundary::computeBmatrixAt(), oofem::MITC4Shell::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::PlaneStress2d::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::QDKTPlate::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::tet21ghostsolid::computeBmatrixAt(), oofem::TR_SHELL11::computeBmatrixAt(), oofem::Tr_Warp::computeBmatrixAt(), oofem::TrPlanestressRotAllman::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBmatrixAt(), oofem::Truss2d::computeBmatrixAt(), oofem::Truss3d::computeBmatrixAt(), oofem::TR1_2D_SUPG2_AXI::computeBMtrx(), oofem::TR1_2D_SUPG_AXI::computeBMtrx(), oofem::Truss3dnl::computeBnlMatrixAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::Lattice2d_mt::computeCapacityMatrix(), oofem::Lattice3d_mt::computeCapacityMatrix(), oofem::KelvinChainMaterial::computeCharCoefficients(), oofem::MaxwellChainMaterial::computeCharCoefficients(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Lattice2d_mt::computeConductivityMatrix(), oofem::Lattice3d_mt::computeConductivityMatrix(), oofem::Beam2d::computeConsistentMassMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::TR1_2D_CBS::computeConsistentMassMtrx(), oofem::PlasticMaterial::computeConsistentModuli(), oofem::FEContactSurface::computeContactPointLocalCoordinates_2d(), oofem::FEContactSurface::computeContactPointLocalCoordinates_3d(), oofem::AnisotropicDamageMaterial::computeCorrectionFactor(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::IntElLine1::computeCovarBaseVectorAt(), oofem::IntElLine1IntPen::computeCovarBaseVectorAt(), oofem::IntElLine1PF::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorAt(), oofem::IntElLine2IntPen::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorsAt(), oofem::IntElSurfQuad1::computeCovarBaseVectorsAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::FRCFCM::computeCrackFibreAngle(), oofem::Lattice3d::computeCrossSectionProperties(), oofem::Lattice3d_mt::computeCrossSectionProperties(), oofem::FEContactPoint::computeCurvature(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::MDM::computeDamageTensor(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::MPlasticMaterial::computeDiagModuli(), oofem::PlasticMaterial::computeDiagModuli(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::TR21_2D_SUPG::computeDivTauMatrix(), oofem::Quad10_2D_SUPG::computeDivUMatrix(), oofem::Tet1_3D_SUPG::computeDivUMatrix(), oofem::TR21_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::TMElement::computeFluxLBToLRotationMatrix(), oofem::UPElement::computeFluxLBToLRotationMatrix(), oofem::SolidShell::computeGeometricStiffness(), oofem::IntElLine1PF::computeGMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Lattice2d_mt::computeGradientMatrixAt(), oofem::Lattice3d_mt::computeGradientMatrixAt(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::Tet1_3D_SUPG::computeGradUMatrix(), oofem::TR21_2D_SUPG::computeGradUMatrix(), oofem::Beam2d::computeGtoLRotationMatrix(), oofem::Beam3d::computeGtoLRotationMatrix(), oofem::BondLink3d::computeGtoLRotationMatrix(), oofem::BondLink3dBoundary::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::InterfaceElem2dLin::computeGtoLRotationMatrix(), oofem::InterfaceElem2dQuad::computeGtoLRotationMatrix(), oofem::InterfaceElement3dTrLin::computeGtoLRotationMatrix(), oofem::Lattice2d::computeGtoLRotationMatrix(), oofem::Lattice2dBoundary::computeGtoLRotationMatrix(), oofem::Lattice3d::computeGtoLRotationMatrix(), oofem::Lattice3dBoundary::computeGtoLRotationMatrix(), oofem::Lattice3dBoundaryTruss::computeGtoLRotationMatrix(), oofem::LatticeBeam3d::computeGtoLRotationMatrix(), oofem::LatticeBeam3dBoundary::computeGtoLRotationMatrix(), oofem::LatticeLink3d::computeGtoLRotationMatrix(), oofem::LatticeLink3dBoundary::computeGtoLRotationMatrix(), oofem::LIBeam2d::computeGtoLRotationMatrix(), oofem::LIBeam2dNL::computeGtoLRotationMatrix(), oofem::LIBeam3d2::computeGtoLRotationMatrix(), oofem::LIBeam3d::computeGtoLRotationMatrix(), oofem::LIBeam3dBoundary::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::RerShell::computeGtoLRotationMatrix(), oofem::SpringElement::computeGtoLRotationMatrix(), oofem::TrPlanestressRotAllman3d::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::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::Structural3DElement::computeInitialStressMatrix(), oofem::Truss3d::computeInitialStressMatrix(), oofem::Truss3dnl2::computeInitialStressStiffness(), oofem::Truss3dnl::computeInitialStressStiffness(), oofem::Beam3d::computeKappaCoeffs(), oofem::Node::computeL2GTransformation(), oofem::InterfaceElement3dTrLin::computeLCS(), oofem::TR1_2D_SUPG2_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeLinearAdvectionTerm_MC(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::Beam3d::computeLoadGToLRotationMtrx(), oofem::CCTPlate3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadGToLRotationMtrx(), oofem::LIBeam2d::computeLoadGToLRotationMtrx(), oofem::LIBeam2dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d2::computeLoadGToLRotationMtrx(), oofem::LIBeam3d::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL2::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL::computeLoadGToLRotationMtrx(), oofem::LinQuad3DPlaneStress::computeLoadGToLRotationMtrx(), oofem::MITC4Shell::computeLoadGToLRotationMtrx(), oofem::TR_SHELL11::computeLoadGToLRotationMtrx(), oofem::TrPlanestressRotAllman3d::computeLoadGToLRotationMtrx(), oofem::TrPlaneStrRot3d::computeLoadGToLRotationMtrx(), oofem::CCTPlate::computeLoadLEToLRotationMatrix(), oofem::DKTPlate3d::computeLoadLEToLRotationMatrix(), oofem::DKTPlate::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::QDKTPlate::computeLoadLEToLRotationMatrix(), oofem::Quad1Mindlin::computeLoadLEToLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLoadLEToLRotationMatrix(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::Truss2d::computeLoadLEToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::tet21ghostsolid::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::MDM::computeLocalDamageTensor(), oofem::TR1_2D_SUPG2::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeLSICStabilizationTerm_MB(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::Beam2d::computeLumpedInitialStressMatrix(), oofem::Beam3d::computeLumpedInitialStressMatrix(), oofem::CCTPlate::computeLumpedMassMatrix(), oofem::DKTPlate::computeLumpedMassMatrix(), oofem::Lattice3d::computeLumpedMassMatrix(), oofem::LIBeam2d::computeLumpedMassMatrix(), oofem::LIBeam2dNL::computeLumpedMassMatrix(), oofem::LIBeam3d2::computeLumpedMassMatrix(), oofem::LIBeam3d::computeLumpedMassMatrix(), oofem::LIBeam3dNL2::computeLumpedMassMatrix(), oofem::LIBeam3dNL::computeLumpedMassMatrix(), oofem::LTRSpace::computeLumpedMassMatrix(), oofem::Quad1Mindlin::computeLumpedMassMatrix(), oofem::RerShell::computeLumpedMassMatrix(), oofem::SpringElement::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::Truss1d::computeLumpedMassMatrix(), oofem::Truss2d::computeLumpedMassMatrix(), oofem::Truss3d::computeLumpedMassMatrix(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::RigidArmNode::computeMasterContribution(), oofem::StrainVector::computeMaxPrincipalDir(), oofem::LIBeam2dNL::computeNLBMatrixAt(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::CCTPlate::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::IntElPoint::computeNmatrixAt(), oofem::IntElSurfQuad1::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::LIBeam2d::computeNmatrixAt(), oofem::LIBeam2dNL::computeNmatrixAt(), oofem::LIBeam3d2::computeNmatrixAt(), oofem::LIBeam3d::computeNmatrixAt(), oofem::LIBeam3dNL2::computeNmatrixAt(), oofem::LIBeam3dNL::computeNmatrixAt(), oofem::MITC4Shell::computeNmatrixAt(), oofem::RerShell::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::TR_SHELL11::computeNmatrixAt(), oofem::TrPlanestressRotAllman::computeNmatrixAt(), oofem::TrPlaneStrRot::computeNmatrixAt(), oofem::Truss1d::computeNmatrixAt(), oofem::Truss2d::computeNmatrixAt(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), computeNorm(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::Lattice2d_mt::computeNSubMatrixAt(), oofem::Lattice3d_mt::computeNSubMatrixAt(), oofem::TR1_2D_SUPG::computeOutFlowBCTerm_MB(), 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_SUPG2::computePressureTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG::computePressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG2::computePressureTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG::computePressureTerm_MC(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MC(), oofem::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), oofem::LIBeam3dNL2::computeQuaternionFromRotMtrx(), oofem::Masonry02::computeReducedElasticModuli(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::Masonry02::computeReducedSKGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::Masonry02::computeReducedSSGradientMatrix(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrxFromQuaternion(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::DKTPlate::computeShearForces(), oofem::TR1_2D_SUPG::computeSlipWithFrictionBCTerm_MB(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::Lattice2dBoundary::computeStiffnessMatrix(), oofem::Lattice3d::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3d::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::MITC4Shell::computeStiffnessMatrix(), oofem::SpringElement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_dd(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::TrPlanestressRotAllman::computeStiffnessMatrixZeroEnergyStabilization(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::DruckerPragerCutMat::computeStressGradientVector(), oofem::RankinePlasticMaterial::computeStressGradientVector(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Tensor2_3d::computeTensorPowerFromEigs(), oofem::AnisotropicDamageMaterial::computeTraceD(), oofem::StructuralInterfaceElement::computeTraction(), oofem::BondLink3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundaryBeam::computeTransformationMatrix(), oofem::LIBeam3dBoundaryMembrane::computeTransformationMatrix(), oofem::LIBeam3dBoundaryPlate::computeTransformationMatrix(), oofem::LIBeam3dBoundaryTruss::computeTransformationMatrix(), oofem::LIBeam3dBoundaryVoigt::computeTransformationMatrix(), oofem::Line::computeTransformationMatrix(), oofem::LTRSpaceBoundary::computeTransformationMatrix(), oofem::LTRSpaceBoundaryBeam::computeTransformationMatrix(), oofem::LTRSpaceBoundaryMembrane::computeTransformationMatrix(), oofem::LTRSpaceBoundaryPlate::computeTransformationMatrix(), oofem::LTRSpaceBoundaryTruss::computeTransformationMatrix(), oofem::LTRSpaceBoundaryVoigt::computeTransformationMatrix(), oofem::IntElLine1::computeTransformationMatrixAt(), oofem::IntElLine1PF::computeTransformationMatrixAt(), oofem::IntElLine1PhF::computeTransformationMatrixAt(), oofem::IntElPoint::computeTransformationMatrixAt(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::GravityPressure::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::LIBeam3dNL2::computeXMtrx(), oofem::LIBeam3dNL::computeXMtrx(), oofem::StructuralElement::condense(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), copySubVectorRow(), oofem::AnisotropicDamageMaterial::correctBigValues(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::LEPlic::doCellDLS(), oofem::CrackExportModule::doOutput(), oofem::LIBeam3dNL2::drawDeformedGeometry(), oofem::NURBSSpace3dElement::drawScalar(), oofem::LSpace::drawTriad(), oofem::Node::drawYourself(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7Base::edgeComputeNmatrixAt(), oofem::FEI3dHexaLin::edgeEvaldNdx(), oofem::FEI3dLineLin::edgeEvaldNdx(), oofem::FEI3dTetLin::edgeEvaldNdx(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::FEI1dHermite::evald2Ndx2(), oofem::FEI2dTrQuad::evald2Ndx2(), oofem::FEI1dHermite::evaldNdx(), oofem::FEI1dLin::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::FEI2dQuadConst::evaldNdx(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI2dTrLin::evaldNdx(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI3dLineLin::evaldNdx(), oofem::FEI3dTetLin::evaldNdx(), oofem::FEI2dLineQuad::evaldNdxi(), oofem::FEI2dQuadBiQuad::evaldNdxi(), oofem::FEI2dQuadQuad::evaldNdxi(), oofem::FEI2dTrQuad::evaldNdxi(), oofem::FEI3dHexaLin::evaldNdxi(), oofem::FEI3dHexaQuad::evaldNdxi(), oofem::FEI3dHexaTriQuad::evaldNdxi(), oofem::FEI3dWedgeLin::evaldNdxi(), oofem::FEI3dWedgeQuad::evaldNdxi(), oofem::Shell7Base::evalInitialCovarBaseVectorsAt(), oofem::dnTaN::evaluate_lin(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::VTKExportModule::exportCellVars(), oofem::VTKExportModule::exportIntVarAs(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase2D(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase3D(), oofem::MisesMatGrad::give1dGprime(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::HyperelasticMaterial1d::give1dStressStiffnessMatrix_dPdF(), oofem::LargeStrainMasterMaterialGrad::give3dGprime(), oofem::MisesMatGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::LargeStrainMasterMaterialGrad::give3dKappaMatrix(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::AnisotropicDamageMaterial::give3dMaterialStiffnessMatrix(), oofem::LayeredCrossSection::give3dShellRotStiffMtrx(), oofem::SimpleCrossSection::give3dShellRotStiffMtrx(), oofem::ExpCZMaterial::give3dStiffnessMatrix_Eng(), oofem::TMSimpleMaterial::giveCharacteristicMatrix(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::UPSimpleMaterial::giveCharacteristicMatrix(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStress2d::giveCharacteristicSize(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TR_SHELL11::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::CompoDamageMat::giveCharLength(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::IsotropicLinearElasticMaterial::giveDeviatoricPlaneStrainStiffMtrx(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_NB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_ud(), oofem::LIBeam3dNL2::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::MisesMatGrad::giveInternalLength(), oofem::RankineMatGrad::giveInternalLength(), oofem::TrabBoneGrad3D::giveInternalLength(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::CCTPlate3d::giveIPValue(), oofem::DKTPlate3d::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::LinQuad3DPlaneStress::giveIPValue(), oofem::MDM::giveIPValue(), oofem::RCM2Material::giveIPValue(), oofem::RerShell::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::tet21ghostsolid::giveIPValue(), oofem::TR_SHELL11::giveIPValue(), oofem::TrPlanestressRotAllman3d::giveIPValue(), oofem::TrPlaneStrRot3d::giveIPValue(), oofem::FEInterpolation2d::giveJacobianMatrixAt(), oofem::Beam2d::giveKappaCoeff(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Beam2d::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::Lattice2d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dBoundary::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::Truss2d::giveLocalCoordinateSystem(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::FEI3dTrQuad::giveLocalNodeCoords(), oofem::FEI3dWedgeQuad::giveLocalNodeCoords(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::MazarsMaterial::giveNormalBlockOfElasticCompliance(), oofem::IDNLMaterial::giveNormalElasticStiffnessMatrix(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), oofem::FCMMaterial::giveNormalLocalCrackedStiffnessMatrix(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::AnisotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::MisesMat::givePlaneStressStiffMtrx(), oofem::MDM::giveRawMDMParameters(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::FRCFCMNL::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::TR_SHELL01::giveRotationMatrix(), oofem::TR_SHELL02::giveRotationMatrix(), oofem::StructuralSlipFE2Material::giveSensitivities(), oofem::IntMatPhaseField::giveTangents(), oofem::FCMMaterial::giveTotalLocalCrackedStiffnessMatrix(), oofem::StrainVector::giveTranformationMtrx(), oofem::StressVector::giveTranformationMtrx(), oofem::Node::giveUpdatedCoordinate(), oofem::FEI3dHexaConst::global2local(), oofem::FEI3dHexaLin::global2local(), oofem::Node::hasSameLCS(), oofem::Quasicontinuum::homogenizationOfStiffMatrix(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::MazarsMaterial::initDamaged(), oofem::FCMMaterial::initializeCrack(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::TransverseReinfConstraint::integrateTangent(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), oofem::HybridEI::interpGradLevelSet(), oofem::FRCFCMNL::isInElementProjection(), oofem::Triangle::isOrientedAnticlockwise(), oofem::FRCFCMNL::isStrengthExceeded(), jaco_(), oofem::TR1_2D_SUPG::LS_PCS_computedN(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_recoverValues(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::LevelSetPCS::pcs_stage1(), oofem::RankineMat::performPlasticityReturn(), oofem::MisesMat::performPlasticityReturn_PlaneStress(), plus_Nt_a_otimes_b_B(), plusDyadSymmUpper(), plusDyadUnsym(), oofem::FloatArray::plusProduct(), plusProductSymmUpper(), plusProductUnsym(), printYourself(), printYourself(), printYourselfToFile(), oofem::PLHoopStressCirc::propagateInterface(), pY(), oofem::Skyline::rbmodes(), oofem::OOFEMTXTInputRecord::readMatrix(), oofem::Shell7Base::recoverShearStress(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::ZZNodalRecoveryModel::recoverValues(), resizeWithData(), oofem::Shell7Base::setupInitialNodeDirectors(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::VTKXMLLatticeExportModule::setupVTKPieceCross(), oofem::Grid::setZeroValues(), oofem::GJacobi::solve(), oofem::SLEPcSolver::solve(), oofem::SubspaceIteration::solve(), solveForRhs(), solveForRhs(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::DEIDynamic::solveYourselfAt(), oofem::StructuralMaterial::sortPrincDirAndValCloseTo(), oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), oofem::FEI3dQuadLin::surfaceEvald2Ndxi2(), oofem::FEI3dTrLin::surfaceEvald2Ndxi2(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEI3dTetLin::surfaceEvaldNdx(), oofem::FEI3dTetQuad::surfaceEvaldNdx(), oofem::FEI3dHexaLin::surfaceEvaldNdxi(), oofem::FEI3dQuadLin::surfaceEvaldNdxi(), oofem::FEI3dTrLin::surfaceEvaldNdxi(), oofem::FEI3dTrQuad::surfaceEvaldNdxi(), oofem::FEI3dQuadLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrQuad::surfaceGiveJacobianMatrixAt(), symmetrized(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::Skyline::toFloatMatrix(), oofem::SkylineUnsym::toFloatMatrix(), oofem::Tr_Warp::transformCoordinates(), oofem::Quasicontinuum::transformStiffnessTensorToMatrix(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::EigenVectorPrimaryField::updateAll(), oofem::PrescribedDispSlipBCDirichletRC::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::Shell7Base::updateLayerTransvNormalStressSR(), oofem::Shell7Base::updateLayerTransvShearStressesSR(), oofem::Shell7Base::updateLayerTransvStressesSR(), oofem::LevelSetPCS::updatePosition(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), writeCSV(), oofem::Skyline::writeToFile(), oofem::SkylineUnsym::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().
| void oofem::FloatMatrix::beDiagonal | ( | const FloatArray & | diag | ) |
Modifies receiver to be a diagonal matrix with the components specified in diag.
Definition at line 1111 of file floatmatrix.C.
References oofem::diag(), and resize().
Referenced by oofem::LineDistributedSpring::computeConstitutiveMatrixAt(), oofem::LumpedMassElement::computeLumpedMassMatrix(), oofem::NodalSpringElement::computeLumpedMassMatrix(), and oofem::NodalSpringElement::computeStiffnessMatrix().
| void oofem::FloatMatrix::beDyadicProductOf | ( | const FloatArray & | vec1, |
| const FloatArray & | vec2 ) |
Assigns to the receiver the dyadic product \( v_1 \cdot v_2^{\mathrm{T}} \) . Grows or shrinks if necessary.
Definition at line 535 of file floatmatrix.C.
References _resize_internal(), oofem::FloatArray::at(), at(), and oofem::FloatArray::giveSize().
Referenced by oofem::IsotropicDamageMaterial1::computeEta(), oofem::PrescribedGradientBCWeak::computeField(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::FEI2dLineHermite::evaldNdx(), oofem::BTamNTerm::evaluate_lin(), oofem::NTcN::evaluate_lin(), oofem::NTN::evaluate_lin(), oofem::IsotropicDamageMaterial::give1dStressStiffMtrx(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_BB(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::IsotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::MisesMat::givePlaneStressStiffMtrx(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), and oofem::IntElLine1PF::solveForLocalDamage().
| bool 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 768 of file floatmatrix.C.
References _resize_internal(), at(), cols(), oofem::det(), FloatMatrix(), oofem::FloatArray::givePointer(), givePointer(), oofem::IntArray::givePointer(), isSquare(), nRows, OOFEM_ERROR, OOFEM_WARNING, rows(), and oofem::zero().
Referenced by oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::PlasticMaterial::computeConsistentModuli(), oofem::StructuralPenaltyContactBoundaryCondition::computeContravariantMetric(), oofem::MazarsMaterial::computeDamageParam(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::PolygonLine::computeIntersectionPoints(), oofem::BasicGeometry::computeLineDistance(), oofem::tet21ghostsolid::computeLoadVector(), oofem::HTSelement::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::PrescribedDispSlipBCNeumannRC::computeWeightMatrix(), oofem::NTmuVfSNTerm::evaluate_lin(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::MDM::giveIPValue(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::PlasticMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::FETISolver::solve(), oofem::SubspaceIteration::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 1646 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::Shell7BaseXFEM::computeCohesiveForces(), oofem::IntElSurfQuad1::computeTransformationMatrixAt(), oofem::IntElSurfTr1::computeTransformationMatrixAt(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), and oofem::Shell7BaseXFEM::recoverShearStress().
| void oofem::FloatMatrix::beMatrixForm | ( | const FloatArray & | aArray | ) |
Definition at line 1689 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::LinearElasticMaterial::giveEshelbyStressVector_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 1806 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), oofem::FloatArray::giveSize(), OOFEM_ERROR, and resize().
Referenced by 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 1633 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::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::MITC4Shell::computeEdgeNMatrix(), oofem::StructuralElement::computeEdgeNMatrix(), oofem::PFEMElement2d::computeEdgeNMatrixAt(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGradientBCWeak::computeField(), oofem::XfemElementInterface::computeNCohesive(), oofem::PlaneStressStructuralElementEvaluator::computeNMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeNMatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::QDKTPlate::computeNmatrixAt(), oofem::Quad1PlateSubSoil::computeNmatrixAt(), oofem::Quad2PlateSubSoil::computeNmatrixAt(), oofem::StructuralContactElement::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::TransportElement::computeNmatrixAt(), oofem::Tria1PlateSubSoil::computeNmatrixAt(), oofem::Tria2PlateSubSoil::computeNmatrixAt(), oofem::Truss3d::computeNmatrixAt(), oofem::Quad10_2D_SUPG::computeNuMatrix(), oofem::Tet1_3D_SUPG::computeNuMatrix(), oofem::TR21_2D_SUPG::computeNuMatrix(), oofem::MITC4Shell::computeSurfaceNMatrix(), oofem::QDKTPlate::computeSurfaceNMatrix(), oofem::StructuralElement::computeSurfaceNMatrix(), oofem::Structural3DElement::computeSurfaceNMatrixAt(), oofem::NTmuVfSNTerm::evaluate_lin(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressSteel(), oofem::TransverseReinfConstraint::integrateTangentOnConcrete(), oofem::TransverseReinfConstraint::integrateTangentOnSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), 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 1600 of file floatmatrix.C.
References FloatMatrix(), and resize().
| void oofem::FloatMatrix::beProductOf | ( | const FloatMatrix & | a, |
| const FloatMatrix & | b ) |
Assigns to the receiver product of \( a \cdot b \) . Grows or shrinks if necessary.
Definition at line 365 of file floatmatrix.C.
References _resize_internal(), at(), cols(), FloatMatrix(), givePointer(), OOFEM_ERROR, and rows().
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::Truss3dnl::computeBnlMatrixAt(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::Shell7Base::computeCauchyStressVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::HTSelement::computeFMatrixAt(), oofem::SolidShell::computeGeometricStiffness(), oofem::Tet1_3D_SUPG::computeGradUMatrix(), oofem::TR21_2D_SUPG::computeGradUMatrix(), oofem::Beam2d::computeGtoLRotationMatrix(), oofem::Beam3d::computeGtoLRotationMatrix(), oofem::Structural3DElement::computeInitialStressMatrix(), oofem::Truss3dnl2::computeInitialStressStiffness(), oofem::DofManager::computeM2GTransformation(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::RigidArmNode::computeMasterContribution(), oofem::PerfectlyPlasticMaterial::computePlasticStiffnessAt(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::HTSelement::computePuVectorAt(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::Beam2d::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Lattice2d::computeStiffnessMatrix(), oofem::Lattice2dBoundary::computeStiffnessMatrix(), oofem::Lattice3d::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::LIBeam3dBoundary::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::LTRSpaceBoundary::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::PFEMElement2d::computeStiffnessMatrix(), oofem::QPlaneStress2dSlip::computeStiffnessMatrix(), oofem::QTrPlaneStress2dSlip::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Truss3dnl2::computeStiffnessMatrix(), oofem::Truss3dnl::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_dd(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_uu(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::GradientDamageElement::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::LIBeam3dNL::computeTempCurv(), oofem::Shell7BaseXFEM::computeTripleProduct(), oofem::TransportGradientDirichlet::computeXi(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::BDalphaPiTerm::evaluate_lin(), oofem::BTdSigmadT::evaluate_lin(), oofem::BTmuBTerm::evaluate_lin(), oofem::BTmuVfBTerm::evaluate_lin(), oofem::BTSigmaTerm2::evaluate_lin(), oofem::BTSigTerm::evaluate_lin(), oofem::dnTaN::evaluate_lin(), oofem::gNTfTerm::evaluate_lin(), oofem::NdTdvfNpTerm::evaluate_lin(), oofem::NTamTBTerm::evaluate_lin(), oofem::NTmuVfSNTerm::evaluate_lin(), oofem::LargeStrainMasterMaterialGrad::give3dGprime(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::MDM::giveIPValue(), oofem::FEI3dTetQuad::giveJacobianMatrixAt(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::Element::giveRotationMatrix(), oofem::Homogenize::herveZaoui(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::operator*(), oofem::PLHoopStressCirc::propagateInterface(), rotatedWith(), and oofem::MDM::rotateTensor4().
| void oofem::FloatMatrix::beProductTOf | ( | const FloatMatrix & | a, |
| const FloatMatrix & | b ) |
Assigns to the receiver product of \( a \cdot b^{\mathrm{T}}\) . Grows or shrinks if necessary.
Definition at line 431 of file floatmatrix.C.
References _resize_internal(), at(), cols(), FloatMatrix(), givePointer(), OOFEM_ERROR, and rows().
Referenced by oofem::StructuralInterfaceElementPhF::computeBd_matrixAt(), oofem::Shell7Base::computeCauchyStressVector(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::SolidShell::computeGeometricStiffness(), oofem::Truss3dnl2::computeInitialStressStiffness(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_ud(), oofem::NURBSSpace3dElement::drawScalar(), oofem::FEI2dTrQuad::evaldNdx(), oofem::PoissonTerm::evaluate_lin(), oofem::LargeStrainMasterMaterialGrad::give3dKappaMatrix(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), and rotatedWith().
| 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 937 of file floatmatrix.C.
References at(), oofem::IntArray::at(), FloatMatrix(), giveNumberOfColumns(), giveNumberOfRows(), oofem::IntArray::giveSize(), oofem::IntArray::maximum(), oofem::IntArray::minimum(), OOFEM_ERROR, and resize().
| void oofem::FloatMatrix::beSubMatrixOf | ( | const FloatMatrix & | src, |
| Index | topRow, | ||
| Index | bottomRow, | ||
| Index | topCol, | ||
| Index | bottomCol ) |
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 val`ue to be added. |
| sc | Determines the column position (receiver's 1-based index) of first src value to be added. */ void setTSubMatrix(const FloatMatrix &src, int sr, int sc); /** 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 901 of file floatmatrix.C.
References at(), cols(), FloatMatrix(), OOFEM_ERROR, resize(), and rows().
Referenced by oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::LIBeam3dBoundary::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::LIBeam3dBoundary::computeStrainVector(), oofem::TransportGradientPeriodic::computeTangent(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::LIBeam3dBoundary::giveInternalForcesVector(), oofem::StructuralFE2Material::givePlaneStressStiffMtrx(), oofem::StructuralSlipFE2Material::givePlaneStressStiffMtrx(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::StructuralMaterial::giveReducedMatrixForm(), oofem::StructuralMaterial::giveReducedSymMatrixForm(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::Shell7Base::recoverShearStress(), oofem::FluidMaterialEvaluator::solveYourself(), and oofem::StructuralMaterialEvaluator::solveYourself().
| void oofem::FloatMatrix::beTProductOf | ( | const FloatMatrix & | a, |
| const FloatMatrix & | b ) |
Assigns to the receiver product of \( a^{\mathrm{T}} \cdot b \) . Grows or shrinks if necessary.
Definition at line 398 of file floatmatrix.C.
References _resize_internal(), at(), cols(), FloatMatrix(), givePointer(), OOFEM_ERROR, and rows().
Referenced by oofem::Truss3dnl2::_computeBmatrixAt(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnTransferStress(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::HTSelement::computeAMatrixAt(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::SolidShell::computeEVector(), oofem::HTSelement::computeFMatrixAt(), oofem::Shell7Base::computeMassMatrix(), oofem::RigidArmNode::computeMasterContribution(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::TrPlanestressRotAllman::computeStiffnessMatrixZeroEnergyStabilization(), oofem::PrescribedDispSlipBCDirichletRC::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::Shell7BaseXFEM::computeTripleProduct(), oofem::BDalphaPiTerm::evaluate_lin(), oofem::BTamNTerm::evaluate_lin(), oofem::BTdSigmadT::evaluate_lin(), oofem::BTmuBTerm::evaluate_lin(), oofem::BTmuVfBTerm::evaluate_lin(), oofem::BTSigmaTerm2::evaluate_lin(), oofem::BTSigTerm::evaluate_lin(), oofem::deltaBTfiNpTerm::evaluate_lin(), oofem::deltaBTNpTerm::evaluate_lin(), oofem::gNTfTerm::evaluate_lin(), oofem::NdTdvfNpTerm::evaluate_lin(), oofem::NTamTBTerm::evaluate_lin(), oofem::NTBdivTerm::evaluate_lin(), oofem::NTmuVfSNTerm::evaluate_lin(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::LinearElasticMaterial::giveEshelbyStressVector_PlaneStrain(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressSteel(), oofem::TransverseReinfConstraint::integrateTangentOnConcrete(), oofem::TransverseReinfConstraint::integrateTangentOnSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressSteel(), 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 351 of file floatmatrix.C.
References _resize_internal(), at(), FloatMatrix(), giveNumberOfColumns(), and giveNumberOfRows().
Referenced by oofem::LinearConstraintBC::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedMean::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::TransverseReinfConstraint::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnTransferStress(), oofem::PhaseFieldElement::computeBd_matrixAt(), oofem::PlaneStressGradDamage::computeBdMatrixAt(), oofem::QPlaneStrainGradDamage::computeBdMatrixAt(), oofem::QPlaneStressGradDamage::computeBdMatrixAt(), oofem::QSpaceGradDamage::computeBdMatrixAt(), oofem::QTrPlaneStrainGradDamage::computeBdMatrixAt(), oofem::QTrPlaneStressGradDamage::computeBdMatrixAt(), oofem::QTRSpaceGradDamage::computeBdMatrixAt(), oofem::QTruss1dGradDamage::computeBdMatrixAt(), oofem::Quad1PlaneStrainGradDamage::computeBdMatrixAt(), oofem::QWedgeGradDamage::computeBdMatrixAt(), oofem::TrPlaneStressGradDamage::computeBdMatrixAt(), oofem::Truss1dGradDamage::computeBdMatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::Truss1d::computeBmatrixAt(), oofem::Truss3dnl::computeBnlMatrixAt(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Lattice3d::computeCrossSectionProperties(), oofem::Lattice3d_mt::computeCrossSectionProperties(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::TransportElement::computeGradientMatrixAt(), oofem::Quad10_2D_SUPG::computeGradPMatrix(), oofem::Tet1_3D_SUPG::computeGradPMatrix(), oofem::TR21_2D_SUPG::computeGradPMatrix(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::Truss3d::computeLoadLEToLRotationMatrix(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::BaseMixedPressureElement::computeStiffnessMatrix(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix(), oofem::Lattice2dBoundary::computeStiffnessMatrix(), oofem::Lattice3d::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::LIBeam3dBoundary::computeStiffnessMatrix(), oofem::LTRSpaceBoundary::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::LIBeam3dBoundary::computeStrainVector(), oofem::HTSelement::computeSvMatrixAt(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::Shell7Base::computeTractionForce(), oofem::HTSelement::computeUgammaMatrixAt(), oofem::HTSelement::computeUvMatrixAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::BondLink3dBoundary::giveInternalForcesVector(), oofem::Lattice2dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeLink3d::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::LIBeam3dBoundary::giveInternalForcesVector(), oofem::LTRSpaceBoundary::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::Shell7BaseXFEM::giveLocalCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveLocalNodeCoordsForExport(), oofem::IntMatPhaseField::giveTangents(), oofem::StrainVector::giveTranformationMtrx(), oofem::StressVector::giveTranformationMtrx(), oofem::gNTfTerm::grad(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::LIBeam3dNL2::postInitialize(), solveForRhs(), solveForRhs(), oofem::PetscSparseMtrx::timesT(), oofem::PetscSparseMtrx::toFloatMatrix(), oofem::TR_SHELL01::ZZErrorEstimatorI_computeLocalStress(), and oofem::TR_SHELL02::ZZErrorEstimatorI_computeLocalStress().
| void oofem::FloatMatrix::beUnitMatrix | ( | ) |
Sets receiver to unity matrix.
Definition at line 1070 of file floatmatrix.C.
References at(), cols(), isSquare(), OOFEM_ERROR, rows(), and oofem::zero().
Referenced by oofem::PrescribedGradientBCWeak::assemble(), oofem::FEContactPoint::compute_dNdxi_matrix(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Element::computeDofTransformationMatrix(), oofem::RigidArmNode::computeMasterContribution(), oofem::StructuralInterfaceElement::computeTraction(), oofem::ElementSide::computeTransformation(), oofem::BondLink3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundaryBeam::computeTransformationMatrix(), oofem::LIBeam3dBoundaryMembrane::computeTransformationMatrix(), oofem::LIBeam3dBoundaryPlate::computeTransformationMatrix(), oofem::LIBeam3dBoundaryTruss::computeTransformationMatrix(), oofem::LIBeam3dBoundaryVoigt::computeTransformationMatrix(), oofem::LTRSpaceBoundary::computeTransformationMatrix(), oofem::LTRSpaceBoundaryBeam::computeTransformationMatrix(), oofem::LTRSpaceBoundaryMembrane::computeTransformationMatrix(), oofem::LTRSpaceBoundaryPlate::computeTransformationMatrix(), oofem::LTRSpaceBoundaryTruss::computeTransformationMatrix(), oofem::LTRSpaceBoundaryVoigt::computeTransformationMatrix(), oofem::VTKBaseExportModule::getCellVariableFromIS(), oofem::TMSimpleMaterial::giveCharacteristicMatrix(), oofem::UPSimpleMaterial::giveCharacteristicMatrix(), oofem::StructuralInterfaceElement::giveEngTraction(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_BB(), oofem::Element::giveLocalCoordinateSystemVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressConcrete(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), and oofem::GJacobi::solve().
| 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 1723 of file floatmatrix.C.
References at(), cols(), FloatMatrix(), and rows().
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 161 of file floatmatrix.C.
References cols(), OOFEM_ERROR, and rows().
Referenced by operator()(), and operator()().
|
inline |
Definition at line 540 of file floatmatrix.h.
References resize().
Referenced by oofem::EngngModel::assemble(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnTransferStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::DummyFEInterpolation::boundarySurfaceEvaldNdx(), oofem::MPlasticMaterial::closestPointReturn(), oofem::SUPGElement2::computeAccelerationTerm_MB(), oofem::SUPGElement2::computeAccelerationTerm_MC(), oofem::Quad10_2D_SUPG::computeAdvectionDeltaTerm(), oofem::TR21_2D_SUPG::computeAdvectionDeltaTerm(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MB(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MC(), oofem::Quad10_2D_SUPG::computeAdvectionEpsilonTerm(), oofem::Quad10_2D_SUPG::computeAdvectionTerm(), oofem::TR21_2D_SUPG::computeAdvectionTerm(), oofem::SUPGElement::computeBCLhsPressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MC(), oofem::SUPGElement::computeBCLhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCLhsTerm_MB(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::LumpedMassElement::computeBmatrixAt(), oofem::NodalSpringElement::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::SpringElement::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::MPElement::computeFluxLBToLRotationMatrix(), oofem::SADGElement::computeFluxLBToLRotationMatrix(), oofem::TMElement::computeFluxLBToLRotationMatrix(), oofem::UPElement::computeFluxLBToLRotationMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Element::computeGtoLRotationMatrix(), oofem::J2MPlasticMaterial::computeHardeningReducedModuli(), oofem::J2plasticMaterial::computeHardeningReducedModuli(), oofem::RankinePlasticMaterial::computeHardeningReducedModuli(), oofem::SUPGElement::computeHomogenizedReinforceTerm_MB(), oofem::SUPGElement::computeHomogenizedReinforceTerm_MC(), oofem::LumpedMassElement::computeInitialStressMatrix(), oofem::NodalSpringElement::computeInitialStressMatrix(), oofem::SpringElement::computeInitialStressMatrix(), oofem::Structural3DElement::computeInitialStressMatrix(), oofem::TransportElement::computeIntSourceLHSMatrix(), oofem::TransportElement::computeIntSourceLHSSubMatrix(), oofem::Node::computeL2GTransformation(), oofem::SUPGElement2::computeLinearAdvectionTerm_MC(), oofem::StructuralElement::computeLoadGToLRotationMtrx(), oofem::LIBeam2d::computeLoadLEToLRotationMatrix(), oofem::LIBeam2dNL::computeLoadLEToLRotationMatrix(), oofem::LIBeam3d2::computeLoadLEToLRotationMatrix(), oofem::LIBeam3d::computeLoadLEToLRotationMatrix(), oofem::LIBeam3dNL2::computeLoadLEToLRotationMatrix(), oofem::LIBeam3dNL::computeLoadLEToLRotationMatrix(), oofem::StructuralElement::computeLoadLEToLRotationMatrix(), oofem::StructuralElement::computeLoadLSToLRotationMatrix(), oofem::SUPGElement2::computeLSICStabilizationTerm_MB(), oofem::Quad10_2D_SUPG::computeLSICTerm(), oofem::TR21_2D_SUPG::computeLSICTerm(), oofem::DofManager::computeM2GTransformation(), oofem::Quad10_2D_SUPG::computeMassDeltaTerm(), oofem::TR21_2D_SUPG::computeMassDeltaTerm(), oofem::Quad10_2D_SUPG::computeMassEpsilonTerm(), oofem::LumpedMassElement::computeNmatrixAt(), oofem::NodalSpringElement::computeNmatrixAt(), oofem::SpringElement::computeNmatrixAt(), oofem::SUPGElement::computeOutFlowBCTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeOutFlowBCTerm_MB(), oofem::SUPGElement::computePenetrationWithResistanceBCTerm_MB(), oofem::TR1_2D_SUPG_AXI::computePenetrationWithResistanceBCTerm_MB(), oofem::SUPGElement2::computePressureTerm_MB(), oofem::SUPGElement2::computePressureTerm_MC(), oofem::RankinePlasticMaterial::computeReducedGradientMatrix(), oofem::SUPGElement::computeSlipWithFrictionBCTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeSlipWithFrictionBCTerm_MB(), oofem::Beam2d::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::LumpedMassElement::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::PFEMElement2d::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::Truss3dnl2::computeStiffnessMatrix(), oofem::Truss3dnl::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_dd(), oofem::PhaseFieldElement::computeStiffnessMatrix_dd(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_pp(), oofem::GradientDamageElement::computeStiffnessMatrix_ud(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_up(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_uu(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::GradientDamageElement::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::Element::computeTangentFromEdgeLoad(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::Element::computeTangentFromSurfaceLoad(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::DummyFEInterpolation::evaldNdx(), oofem::FEI2dLineConst::evaldNdx(), oofem::FEI2dLineLin::evaldNdx(), oofem::FEI2dLineQuad::evaldNdx(), oofem::ContactElement::giveCharacteristicMatrix(), oofem::Line2BoundaryElement::giveCharacteristicMatrix(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::SADGElement::giveCharacteristicMatrix(), oofem::MPElement::giveCharacteristicMatrixFromBC(), oofem::SADGBoundaryElement::giveCharacteristicMatrixFromBC(), oofem::SADGElement::giveCharacteristicMatrixFromBC(), oofem::TMElement::giveCharacteristicMatrixFromBC(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::GradientDamageMaterialExtensionInterface::giveGradientDamageStiffnessMatrix_dd_BN(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_BN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_BN(), oofem::GradientDamageMaterialExtensionInterface::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_NB(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::SolidShell::giveInternalForcesVector(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Element::giveLocalCoordinateSystem(), oofem::PlasticMaterial::giveRealStressVector(), oofem::Element::giveRotationMatrix(), oofem::Shell7Base::giveSPRcontribution(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::TransportGradientNeumann::integrateTangent(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressSteel(), oofem::TransverseReinfConstraint::integrateTangentOnConcrete(), oofem::TransverseReinfConstraint::integrateTangentOnSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent(), oofem::TR21_2D_SUPG::LS_PCS_computedN(), oofem::EffectiveTangentAssembler::matrixFromEdgeLoad(), oofem::MatrixAssembler::matrixFromEdgeLoad(), oofem::MatrixAssembler::matrixFromElement(), oofem::EffectiveTangentAssembler::matrixFromLoad(), oofem::MatrixAssembler::matrixFromLoad(), oofem::TangentAssembler::matrixFromLoad(), oofem::MatrixAssembler::matrixFromSurfaceLoad(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::MisesMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::RankineMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::TrabBoneNL3D::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::Skyline::rbmodes(), oofem::OOFEMTXTInputRecord::readMatrix(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNValProduct().
|
inline |
Definition at line 130 of file floatmatrix.h.
References nColumns.
Referenced by add(), add(), addProductOf(), addTProductOf(), assignFloatMatrixF(), beInverseOf(), beProductOf(), beProductTOf(), oofem::FloatArray::beRowOf(), beSubMatrixOf(), beTProductOf(), beUnitMatrix(), changeComponentOrder(), checkBounds(), computeNorm(), oofem::FloatMatrixF< N, M >::FloatMatrixF(), fromArray(), giveDeterminant(), oofem::XMLInputRecord::giveField(), giveNumberOfColumns(), givePackSize(), giveTrace(), isAllFinite(), isNotEmpty(), isSquare(), operator<<, plusDyadSymmUpper(), plusDyadUnsym(), plusProductSymmUpper(), plusProductUnsym(), printYourself(), printYourself(), printYourselfToFile(), pY(), resizeWithData(), solveForRhs(), solveForRhs(), storeYourself(), subtract(), symmetrized(), and writeCSV().
| 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 1170 of file floatmatrix.C.
References _LOOP_MATRIX.
Referenced by oofem::TransportGradientNeumann::computeTangent(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::Quad10_2D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), and oofem::TR21_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 1179 of file floatmatrix.C.
References at(), cols(), oofem::FloatArray::givePointer(), givePointer(), oofem::max(), oofem::norm(), OOFEM_ERROR, and rows().
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 1769 of file floatmatrix.C.
References computeNorm(), FloatMatrix(), giveDeterminant(), oofem::FloatArray::givePointer(), givePointer(), oofem::IntArray::givePointer(), oofem::inv(), isSquare(), OOFEM_ERROR, and oofem::rcond().
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 654 of file floatmatrix.C.
References giveNumberOfColumns(), giveNumberOfRows(), OOFEM_ERROR, and oofem::FloatArray::resize().
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 1222 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), giveNumberOfColumns(), giveNumberOfRows(), oofem::FloatArray::giveSize(), oofem::max(), and resizeWithData().
Referenced by oofem::DofManager::computeM2LTransformation().
|
inline |
Definition at line 158 of file floatmatrix.h.
References values.
|
inline |
Definition at line 157 of file floatmatrix.h.
References values.
Referenced by givePointer(), and givePointer().
|
static |
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 1046 of file floatmatrix.C.
References cols(), FloatMatrix(), resize(), rows(), and oofem::FloatArray::size().
Referenced by oofem::Truss3dnl2::_computeBmatrixAt(), oofem::PrescribedMean::assemble(), oofem::Truss3dnl::computeBnlMatrixAt(), oofem::Truss3dnl2::computeInitialStressStiffness(), oofem::PerfectlyPlasticMaterial::computePlasticStiffnessAt(), oofem::GradientDamageElement::computeStiffnessMatrix_dd(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_pp(), oofem::GradientDamageElement::computeStiffnessMatrix_ud(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_up(), oofem::BDalphaPiTerm::evaluate_lin(), oofem::BTdSigmadT::evaluate_lin(), oofem::deltaBTfiNpTerm::evaluate_lin(), oofem::deltaBTNpTerm::evaluate_lin(), oofem::dnTaN::evaluate_lin(), oofem::NdTdvfNpTerm::evaluate_lin(), oofem::NTamTBTerm::evaluate_lin(), oofem::NTBdivTerm::evaluate_lin(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_BN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_BN(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_du(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_ud(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::PlasticMaterial::giveRealStressVector(), oofem::PrescribedDispSlipMultiple::setDispGradient(), and oofem::PrescribedDispSlipMultiple::setSlipGradient().
|
static |
Definition at line 144 of file floatmatrix.C.
References FloatMatrix(), OOFEM_ERROR, and rows().
Referenced by oofem::Shell7BaseXFEM::giveLocalCZNodeCoordsForExport(), and oofem::Shell7BaseXFEM::giveLocalNodeCoordsForExport().
|
static |
Definition at line 126 of file floatmatrix.C.
References _resize_internal(), FloatMatrix(), OOFEM_ERROR, and rows().
Referenced by oofem::Structural3DElement::computeConstitutiveMatrix_dPdF_At(), oofem::Structural3DElement::computeConstitutiveMatrixAt(), FloatMatrix(), and operator=().
| 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 1085 of file floatmatrix.C.
References cols(), FloatMatrix(), isSquare(), OOFEM_ERROR, and rows().
Referenced by oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::NLStructuralElement::computeCurrentVolume(), oofem::SolidShell::computeEASBmatrixAt(), oofem::PolygonLine::computeIntersectionPoints(), oofem::MeshQualityErrorEstimator::computeJacobianError(), oofem::tet21ghostsolid::computeLoadVector(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), computeReciprocalCondition(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::BSplineInterpolation::evaldNdx(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::NURBSInterpolation::evaldNdx(), oofem::TSplineInterpolation::evaldNdx(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::FEI3dWedgeLin::giveTransformationJacobian(), oofem::FEI3dWedgeQuad::giveTransformationJacobian(), oofem::FEInterpolation::giveTransformationJacobian(), and oofem::Triangle::isOrientedAnticlockwise().
|
inline |
Returns number of columns of receiver.
Definition at line 203 of file floatmatrix.h.
References cols().
Referenced by addSubVectorCol(), addSubVectorRow(), oofem::CompCol::assemble(), oofem::ContactBoundaryCondition::assemble(), oofem::DynCompCol::assemble(), assemble(), oofem::Skyline::assemble(), oofem::SpoolesSparseMtrx::assemble(), oofem::SymCompCol::assemble(), oofem::ContactBoundaryCondition::assembleExtrapolatedForces(), assembleT(), oofem::FloatArray::beProductOf(), beSubMatrixOf(), oofem::FloatArray::beSymVectorForm(), oofem::FloatArray::beSymVectorFormOfStrain(), oofem::FloatArray::beTProductOf(), beTranspositionOf(), oofem::FloatArray::beVectorForm(), oofem::ContactPair::compute_dNdxi_matrices(), oofem::TransportElement::computeBmatrixAt(), oofem::Element::computeDofTransformationMatrix(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::TransportElement::computeFlow(), oofem::ContactPair::computeNmatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::TransportGradientDirichlet::computeXi(), copyColumn(), oofem::Shell7Base::CopyIPvaluesToNodes(), copySubVectorRow(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::StructuralElement::giveCharacteristicVector(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::Shell7Base::giveFictiousCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousCZNodeCoordsForExport(), oofem::Shell7Base::giveFictiousNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedCZNodeCoordsForExport(), oofem::Shell7Base::giveFictiousUpdatedNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedNodeCoordsForExport(), oofem::StructuralMaterial::giveIPValue(), oofem::Shell7Base::giveL2contribution(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::Element::giveRotationMatrix(), oofem::TR_SHELL01::giveRotationMatrix(), oofem::TR_SHELL02::giveRotationMatrix(), oofem::Shell7Base::giveTractionBC(), oofem::Homogenize::herveZaoui(), oofem::AnisotropicMassTransferMaterial::initializeFrom(), oofem::TransverseReinfConstraint::integrateTangent(), oofem::HybridEI::interpGradLevelSet(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_recoverValues(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::FloatArray::plusProduct(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), setColumn(), setSubMatrix(), oofem::Grid::setZeroValues(), oofem::SparseLinearSystemNM::solve(), solveForRhs(), oofem::PetscSparseMtrx::times(), oofem::PetscSparseMtrx::timesT(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::EigenVectorPrimaryField::updateAll(), oofem::PFEMCorrectionRhsAssembler::vectorFromElement(), and oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct().
|
inline |
Returns number of rows of receiver.
Definition at line 200 of file floatmatrix.h.
References rows().
Referenced by addSubVectorCol(), addSubVectorRow(), oofem::MDM::applyDamageToStiffness(), oofem::CompCol::assemble(), oofem::CompCol::assemble(), oofem::ContactBoundaryCondition::assemble(), oofem::DynCompCol::assemble(), oofem::DynCompCol::assemble(), oofem::DynCompRow::assemble(), assemble(), oofem::PetscSparseMtrx::assemble(), oofem::Skyline::assemble(), oofem::Skyline::assemble(), oofem::SkylineUnsym::assemble(), oofem::SpoolesSparseMtrx::assemble(), oofem::SpoolesSparseMtrx::assemble(), oofem::SymCompCol::assemble(), oofem::SymCompCol::assemble(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::ContactBoundaryCondition::assembleExtrapolatedForces(), assembleT(), oofem::FloatArray::beProductOf(), beSubMatrixOf(), oofem::FloatArray::beSymVectorForm(), oofem::FloatArray::beSymVectorFormOfStrain(), oofem::FloatArray::beTProductOf(), beTranspositionOf(), oofem::FloatArray::beVectorForm(), oofem::AnisotropicDamageMaterial::checkSymmetry(), oofem::Homogenize::checkVolFraction(), oofem::MPlasticMaterial::closestPointReturn(), oofem::ContactPair::compute_dNdxi_matrices(), oofem::FEContactPoint::compute_dNdxi_matrix(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::LTRSpaceBoundary::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PFEMElement2d::computeBMatrix(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::LSpace::computeBmatrixAt(), oofem::LTRSpaceBoundary::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::PlasticMaterial::computeConsistentModuli(), oofem::IntElLine1::computeCovarBaseVectorAt(), oofem::IntElLine1PF::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorAt(), oofem::IntElLine2IntPen::computeCovarBaseVectorAt(), oofem::IntElSurfQuad1::computeCovarBaseVectorsAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::FRCFCM::computeCrackFibreAngle(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::MPlasticMaterial::computeDiagModuli(), oofem::PlasticMaterial::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::tet21ghostsolid::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::ContactPair::computeNmatrix(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::PlaneStress2dXfem::computeStiffnessMatrix(), oofem::QTrPlaneStress2dXFEM::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::TrPlaneStress2dXFEM::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_dd(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), copyColumn(), copySubVectorRow(), oofem::AnisotropicDamageMaterial::correctBigValues(), oofem::Homogenize::counto(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::Homogenize::gamma(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::TrPlaneStress2dXFEM::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::FEI3dHexaQuad::giveJacobianMatrixAt(), oofem::FEI3dTetQuad::giveJacobianMatrixAt(), oofem::FEInterpolation2d::giveJacobianMatrixAt(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::PlasticMaterial::giveRealStressVector(), oofem::Element::giveRotationMatrix(), oofem::Shell7Base::giveTractionBC(), oofem::Node::giveUpdatedCoordinate(), oofem::Homogenize::hansen(), oofem::Homogenize::hashinShtrikmanWalpole(), oofem::Homogenize::herveZaoui(), oofem::FCMMaterial::initializeCrack(), oofem::AnisotropicMassTransferMaterial::initializeFrom(), oofem::HybridEI::interpGradLevelSet(), jaco_(), oofem::Homogenize::kusterToksoz(), oofem::Homogenize::moriTanaka(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_recoverValues(), oofem::FloatArray::plusProduct(), oofem::Homogenize::reuss(), oofem::MDM::rotateTensor4(), oofem::Homogenize::selfConsistent(), setColumn(), setSubMatrix(), oofem::Grid::setZeroValues(), oofem::GJacobi::solve(), oofem::SparseLinearSystemNM::solve(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::DEIDynamic::solveYourselfAt(), 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 1938 of file floatmatrix.C.
References cols(), oofem::DataStream::givePackSizeOfDouble(), oofem::DataStream::givePackSizeOfSizet(), and rows().
Referenced by oofem::MDM::estimatePackSize().
|
inline |
Definition at line 580 of file floatmatrix.h.
References data().
|
inline |
Exposes the internal values of the matrix. Should typically not be used outside of matrix classes.
Definition at line 579 of file floatmatrix.h.
References data().
Referenced by add(), add(), addProductOf(), addTProductOf(), oofem::PetscSparseMtrx::assemble(), oofem::PetscSparseMtrx::assemble(), beInverseOf(), oofem::FloatArray::beProductOf(), beProductOf(), beProductTOf(), oofem::FloatArray::beTProductOf(), beTProductOf(), computeNorm(), computeReciprocalCondition(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::FloatArray::plusProduct(), plusProductSymmUpper(), plusProductUnsym(), solveForRhs(), solveForRhs(), subtract(), oofem::PetscSparseMtrx::times(), oofem::PetscSparseMtrx::timesT(), and oofem::PetscSparseMtrx::toFloatMatrix().
| double oofem::FloatMatrix::giveTrace | ( | ) | const |
Returns the trace of the receiver. The receiver should be a square matrix.
Definition at line 1121 of file floatmatrix.C.
References cols(), isSquare(), OOFEM_ERROR, and rows().
Referenced by oofem::AnisotropicDamageMaterial::computeKappa().
| bool oofem::FloatMatrix::isAllFinite | ( | ) | const |
Returns true if no element is NAN or infinite.
Definition at line 339 of file floatmatrix.C.
References cols(), and rows().
Referenced by oofem::LSPrimaryVariableMapper::mapPrimaryVariables().
|
inline |
Tests for empty matrix.
Definition at line 210 of file floatmatrix.h.
References cols(), and rows().
Referenced by add(), add(), oofem::EngngModel::assemble(), oofem::EngngModel::assemble(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DGProblem::assembleDirichletBcRhsVector(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::TransportElement::computeBCMtrxAt(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TR_SHELL01::giveCharacteristicMatrix(), oofem::TR_SHELL02::giveCharacteristicMatrix(), oofem::Element::giveRotationMatrix(), oofem::ScalarAdvectionLhsAssembler::matrixFromElement(), oofem::SUPGTangentAssembler::matrixFromElement(), oofem::TMLhsAssembler::matrixFromElement(), plus_Nt_a_otimes_b_B(), plusDyadSymmUpper(), plusDyadUnsym(), plusProductSymmUpper(), plusProductUnsym(), oofem::DEIDynamic::solveYourselfAt(), subtract(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::ScalarAdvectionRhsAssembler::vectorFromElement(), and oofem::SUPGInternalForceAssembler::vectorFromElement().
|
inline |
Returns nonzero if receiver is square matrix.
Definition at line 208 of file floatmatrix.h.
References cols(), and rows().
Referenced by assemble(), beInverseOf(), beUnitMatrix(), computeReciprocalCondition(), oofem::StructuralElement::condense(), giveDeterminant(), giveTrace(), jaco_(), oofem::GJacobi::solve(), solveForRhs(), and solveForRhs().
| 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 1953 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), FloatMatrix(), giveNumberOfRows(), isSquare(), OOFEM_ERROR, oofem::FloatArray::resize(), resize(), and oofem::sum().
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 1164 of file floatmatrix.C.
References _LOOP_MATRIX.
Referenced by oofem::MixedGradientPressureNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::TransverseReinfConstraint::assemble(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnTransferStress(), oofem::TR1_2D_SUPG::computeOutFlowBCTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeOutFlowBCTerm_MB(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientDirichlet::computeXi(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::LinearElasticMaterial::giveEshelbyStressVector_PlaneStrain(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::TransverseReinfConstraint::integrateTangentOnConcrete(), 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 138 of file floatmatrix.h.
References checkBounds(), nRows, and values.
|
inline |
Coefficient access function. Implements 0-based indexing.
| i | Row position of coefficient. |
| j | Column position of coefficient. |
Definition at line 150 of file floatmatrix.h.
References checkBounds(), nRows, and values.
|
inline |
Assignment operator, adjusts size of the receiver if necessary.
Definition at line 117 of file floatmatrix.h.
References FloatMatrix(), nColumns, nRows, and values.
|
inline |
Definition at line 186 of file floatmatrix.h.
References assignFloatMatrixF(), and FloatMatrix().
|
inlinenoexcept |
Definition at line 123 of file floatmatrix.h.
References FloatMatrix(), nColumns, nRows, and values.
|
inline |
Definition at line 169 of file floatmatrix.h.
References FloatMatrix(), and fromIniList().
| void oofem::FloatMatrix::plus_Nt_a_otimes_b_B | ( | const FloatMatrix & | N, |
| const FloatArray & | a, | ||
| const FloatArray & | b, | ||
| const FloatMatrix & | B, | ||
| double | dV = 1 ) |
Adds to the receiver the product \(Nt a \otimes b B \mathrm{d}V\). If the receiver has zero size, it is expanded.
| N | matrix N in equation. |
| a | Array a in equation. |
| b | Array b in equation. |
| B | matrix N in equation. |
| dV | Scaling factor. |
Definition at line 745 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), FloatMatrix(), oofem::FloatArray::giveSize(), isNotEmpty(), N, nColumns, nRows, and values.
Referenced by oofem::StructuralPenaltyContactBoundaryCondition::computeTangentFromContact().
| void oofem::FloatMatrix::plusDyadSymmUpper | ( | const FloatArray & | a, |
| double | dV ) |
Adds to the receiver the dyadic product \( a \otimes a \mathrm{d}V \). 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 667 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), cols(), oofem::FloatArray::givePointer(), oofem::FloatArray::giveSize(), isNotEmpty(), resize(), and rows().
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::MITC4Shell::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 \(a \otimes b \mathrm{d}V\). 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 723 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), cols(), oofem::FloatArray::givePointer(), oofem::FloatArray::giveSize(), isNotEmpty(), resize(), and rows().
Referenced by oofem::tet21ghostsolid::computeLoadVector(), oofem::TR1_2D_SUPG_AXI::computeOutFlowBCTerm_MB(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportGradientDirichlet::computeXi(), oofem::NTaTmTe::evaluate_lin(), oofem::TransportGradientNeumann::integrateTangent(), oofem::Shell7Base::NodalRecoveryMI_computeNValProduct(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::MisesMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::RankineMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::TrabBoneNL3D::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 \( a^{\mathrm{T}}\cdot b \mathrm{d}V \). If the receiver has zero size, it is expanded. Assumes that receiver and product \( a^{\mathrm{T}}\cdot b \mathrm{d}V \) 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 1243 of file floatmatrix.C.
References at(), cols(), FloatMatrix(), givePointer(), isNotEmpty(), resize(), and rows().
Referenced by oofem::Shell7Base::computeBulkTangentMatrix(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeLSICStabilizationTerm_MB(), oofem::Quad10_2D_SUPG::computeLSICTerm(), oofem::TR21_2D_SUPG::computeLSICTerm(), oofem::Shell7Base::computeMassMatrixNum(), oofem::SUPGElement2::computePressureTerm_MC(), oofem::Beam2d::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Truss3dnl2::computeStiffnessMatrix(), oofem::Truss3dnl::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix_dd(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_uu(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::GradientDamageElement::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::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(), and oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix().
| void oofem::FloatMatrix::plusProductUnsym | ( | const FloatMatrix & | a, |
| const FloatMatrix & | b, | ||
| double | dV ) |
Adds to the receiver the product \(a^{\mathrm{T}} \cdot b \mathrm{d}V\). 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 691 of file floatmatrix.C.
References at(), cols(), FloatMatrix(), givePointer(), isNotEmpty(), resize(), and rows().
Referenced by oofem::SUPGElement2::computeAccelerationTerm_MB(), oofem::SUPGElement2::computeAccelerationTerm_MC(), oofem::Quad10_2D_SUPG::computeAdvectionDeltaTerm(), oofem::TR21_2D_SUPG::computeAdvectionDeltaTerm(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MB(), oofem::SUPGElement2::computeAdvectionDerivativeTerm_MC(), oofem::Quad10_2D_SUPG::computeAdvectionEpsilonTerm(), oofem::Quad10_2D_SUPG::computeAdvectionTerm(), oofem::TR21_2D_SUPG::computeAdvectionTerm(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MC(), oofem::SolidShell::computeEASBmatrixAt(), oofem::Structural3DElement::computeInitialStressMatrix(), oofem::SUPGElement2::computeLinearAdvectionTerm_MC(), oofem::Quad10_2D_SUPG::computeMassDeltaTerm(), oofem::TR21_2D_SUPG::computeMassDeltaTerm(), oofem::Quad10_2D_SUPG::computeMassEpsilonTerm(), oofem::SUPGElement2::computePressureTerm_MB(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Lattice2d::computeStiffnessMatrix(), oofem::Lattice2dBoundary::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::PFEMElement2d::computeStiffnessMatrix(), oofem::QPlaneStress2dSlip::computeStiffnessMatrix(), oofem::QTrPlaneStress2dSlip::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::SolidShell::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::Truss3dnl2::computeStiffnessMatrix(), oofem::Truss3dnl::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_dd(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_pp(), oofem::GradientDamageElement::computeStiffnessMatrix_ud(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_up(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_uu(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::GradientDamageElement::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Shell7BaseXFEM::discComputeStiffness(), and oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent().
| void oofem::FloatMatrix::printYourself | ( | ) | const |
Definition at line 1501 of file floatmatrix.C.
References at(), cols(), and rows().
Referenced by oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::PoissonElement::giveCharacteristicMatrix(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Skyline::printYourself(), oofem::SkylineUnsym::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 1542 of file floatmatrix.C.
| void oofem::FloatMatrix::printYourselfToFile | ( | const std::string | filename, |
| const bool | showDimensions = true ) const |
Print matrix to file.
| filename | Output filename @parap showDimensions Determines if dimensions should be included in output. Default is true. |
Definition at line 1520 of file floatmatrix.C.
References at(), cols(), OOFEM_ERROR, and rows().
Referenced by oofem::tet21ghostsolid::computeStiffnessMatrix().
| void oofem::FloatMatrix::pY | ( | ) | const |
Definition at line 1567 of file floatmatrix.C.
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 79 of file floatmatrix.C.
References nColumns, nRows, rows(), and values.
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::WeakPeriodicBoundaryCondition::assemble(), assignFloatMatrixF(), beDiagonal(), beLocalCoordSys(), beMatrixForm(), beMatrixFormOfStress(), beNMatrixOf(), bePinvID(), beSubMatrixOf(), beSubMatrixOf(), oofem::FCMMaterial::checkStrengthCriterion(), clear(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::Tr2Shell7::compareMatrices(), oofem::ContactPair::compute_dNdxi_matrices(), oofem::FEContactPoint::compute_dNdxi_matrix(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::TR1_2D_SUPG2::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MC(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::TransportElement::computeBCMtrxAt(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::LTRSpaceBoundary::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::PlaneStress2d::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::Quad1PlaneStrain::computeBHmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PFEMElement2d::computeBMatrix(), oofem::Quad10_2D_SUPG::computeBMatrix(), oofem::Tet1_3D_SUPG::computeBMatrix(), oofem::TR21_2D_SUPG::computeBMatrix(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::computeBmatrixAt(), oofem::BondLink3d::computeBmatrixAt(), oofem::CCTPlate::computeBmatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::DKTPlate::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElem2dQuad::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::Lattice2dBoundary::computeBmatrixAt(), oofem::Lattice3d::computeBmatrixAt(), oofem::Lattice3dBoundary::computeBmatrixAt(), oofem::Lattice3dBoundaryTruss::computeBmatrixAt(), oofem::LatticeLink3d::computeBmatrixAt(), oofem::LIBeam2d::computeBmatrixAt(), oofem::LIBeam2dNL::computeBmatrixAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::LIBeam3d::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::LSpace::computeBmatrixAt(), oofem::LSpaceBB::computeBmatrixAt(), oofem::LTRSpaceBoundary::computeBmatrixAt(), oofem::MITC4Shell::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::PlaneStress2d::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::QDKTPlate::computeBmatrixAt(), oofem::Quad1Mindlin::computeBmatrixAt(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::Quad1PlateSubSoil::computeBmatrixAt(), oofem::Quad2PlateSubSoil::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::tet21ghostsolid::computeBmatrixAt(), oofem::TR_SHELL11::computeBmatrixAt(), oofem::Tr_Warp::computeBmatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::Tria1PlateSubSoil::computeBmatrixAt(), oofem::Tria2PlateSubSoil::computeBmatrixAt(), oofem::TrPlanestressRotAllman::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBmatrixAt(), oofem::Truss2d::computeBmatrixAt(), oofem::Truss3d::computeBmatrixAt(), oofem::TR1_2D_SUPG2_AXI::computeBMtrx(), oofem::TR1_2D_SUPG_AXI::computeBMtrx(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::Lattice2d_mt::computeCapacityMatrix(), oofem::Lattice3d_mt::computeCapacityMatrix(), oofem::TransportElement::computeCapacityMatrix(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::Lattice2d_mt::computeConductivityMatrix(), oofem::Lattice3d_mt::computeConductivityMatrix(), oofem::TransportElement::computeConductivityMatrix(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::AbaqusUserElement::computeConsistentMassMatrix(), oofem::Beam2d::computeConsistentMassMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::TR1_2D_CBS::computeConsistentMassMtrx(), oofem::PlasticMaterial::computeConsistentModuli(), oofem::LineDistributedSpring::computeConstitutiveMatrixAt(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::IntElLine1PhF::computeCovarBaseVectorsAt(), oofem::FEContactPoint::computeCurvature(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::MPlasticMaterial::computeDiagModuli(), oofem::PlasticMaterial::computeDiagModuli(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::Quad10_2D_SUPG::computeDivTauMatrix(), oofem::Tet1_3D_SUPG::computeDivTauMatrix(), oofem::TR21_2D_SUPG::computeDivTauMatrix(), oofem::Quad10_2D_SUPG::computeDivUMatrix(), oofem::Tet1_3D_SUPG::computeDivUMatrix(), oofem::TR21_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::TMElement::computeFluxLBToLRotationMatrix(), oofem::UPElement::computeFluxLBToLRotationMatrix(), oofem::SolidShell::computeGeometricStiffness(), oofem::IntElLine1PF::computeGMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Lattice2d_mt::computeGradientMatrixAt(), oofem::Lattice3d_mt::computeGradientMatrixAt(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::Beam2d::computeGtoLRotationMatrix(), oofem::Beam3d::computeGtoLRotationMatrix(), oofem::BondLink3d::computeGtoLRotationMatrix(), oofem::BondLink3dBoundary::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::InterfaceElem2dLin::computeGtoLRotationMatrix(), oofem::InterfaceElem2dQuad::computeGtoLRotationMatrix(), oofem::InterfaceElement3dTrLin::computeGtoLRotationMatrix(), oofem::Lattice2d::computeGtoLRotationMatrix(), oofem::Lattice2dBoundary::computeGtoLRotationMatrix(), oofem::Lattice3d::computeGtoLRotationMatrix(), oofem::Lattice3dBoundary::computeGtoLRotationMatrix(), oofem::Lattice3dBoundaryTruss::computeGtoLRotationMatrix(), oofem::LatticeBeam3d::computeGtoLRotationMatrix(), oofem::LatticeBeam3dBoundary::computeGtoLRotationMatrix(), oofem::LatticeLink3d::computeGtoLRotationMatrix(), oofem::LatticeLink3dBoundary::computeGtoLRotationMatrix(), oofem::LIBeam2d::computeGtoLRotationMatrix(), oofem::LIBeam2dNL::computeGtoLRotationMatrix(), oofem::LIBeam3d2::computeGtoLRotationMatrix(), oofem::LIBeam3d::computeGtoLRotationMatrix(), oofem::LIBeam3dBoundary::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeGtoLRotationMatrix(), oofem::RerShell::computeGtoLRotationMatrix(), oofem::SpringElement::computeGtoLRotationMatrix(), oofem::TR_SHELL11::computeGtoLRotationMatrix(), oofem::TrPlanestressRotAllman3d::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::J2MPlasticMaterial::computeHardeningReducedModuli(), oofem::J2plasticMaterial::computeHardeningReducedModuli(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Structural3DElement::computeInitialStressMatrix(), oofem::Truss3d::computeInitialStressMatrix(), oofem::Truss3dnl::computeInitialStressStiffness(), oofem::TransportElement::computeIntSourceLHSMatrix(), oofem::Node::computeL2GTransformation(), oofem::InterfaceElement3dTrLin::computeLCS(), oofem::TR1_2D_SUPG2_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeLinearAdvectionTerm_MC(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::Beam3d::computeLoadGToLRotationMtrx(), oofem::CCTPlate3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadGToLRotationMtrx(), oofem::LIBeam2d::computeLoadGToLRotationMtrx(), oofem::LIBeam2dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d2::computeLoadGToLRotationMtrx(), oofem::LIBeam3d::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL2::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL::computeLoadGToLRotationMtrx(), oofem::LinQuad3DPlaneStress::computeLoadGToLRotationMtrx(), oofem::MITC4Shell::computeLoadGToLRotationMtrx(), oofem::TR_SHELL11::computeLoadGToLRotationMtrx(), oofem::TrPlanestressRotAllman3d::computeLoadGToLRotationMtrx(), oofem::TrPlaneStrRot3d::computeLoadGToLRotationMtrx(), oofem::CCTPlate::computeLoadLEToLRotationMatrix(), oofem::DKTPlate3d::computeLoadLEToLRotationMatrix(), oofem::DKTPlate::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::QDKTPlate::computeLoadLEToLRotationMatrix(), oofem::Quad1Mindlin::computeLoadLEToLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLoadLEToLRotationMatrix(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::Truss2d::computeLoadLEToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::MDM::computeLocalDamageTensor(), oofem::TR1_2D_SUPG2::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeLSICStabilizationTerm_MB(), oofem::Beam2d::computeLumpedInitialStressMatrix(), oofem::Beam3d::computeLumpedInitialStressMatrix(), oofem::CCTPlate::computeLumpedMassMatrix(), oofem::DKTPlate::computeLumpedMassMatrix(), oofem::InterfaceElem1d::computeLumpedMassMatrix(), oofem::Lattice3d::computeLumpedMassMatrix(), oofem::LIBeam2d::computeLumpedMassMatrix(), oofem::LIBeam2dNL::computeLumpedMassMatrix(), oofem::LIBeam3d2::computeLumpedMassMatrix(), oofem::LIBeam3d::computeLumpedMassMatrix(), oofem::LIBeam3dNL2::computeLumpedMassMatrix(), oofem::LIBeam3dNL::computeLumpedMassMatrix(), oofem::LTRSpace::computeLumpedMassMatrix(), oofem::LumpedMassElement::computeLumpedMassMatrix(), oofem::NodalSpringElement::computeLumpedMassMatrix(), oofem::Quad1Mindlin::computeLumpedMassMatrix(), oofem::Quad1MindlinShell3D::computeLumpedMassMatrix(), oofem::RerShell::computeLumpedMassMatrix(), oofem::SpringElement::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::Truss1d::computeLumpedMassMatrix(), oofem::Truss2d::computeLumpedMassMatrix(), oofem::Truss3d::computeLumpedMassMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::LIBeam2dNL::computeNLBMatrixAt(), oofem::ContactPair::computeNmatrix(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::CCTPlate::computeNmatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::IntElPoint::computeNmatrixAt(), oofem::IntElSurfQuad1::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::LIBeam2d::computeNmatrixAt(), oofem::LIBeam2dNL::computeNmatrixAt(), oofem::LIBeam3d2::computeNmatrixAt(), oofem::LIBeam3d::computeNmatrixAt(), oofem::LIBeam3dNL2::computeNmatrixAt(), oofem::LIBeam3dNL::computeNmatrixAt(), oofem::MITC4Shell::computeNmatrixAt(), oofem::RerShell::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::TR_SHELL11::computeNmatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::TrPlanestressRotAllman::computeNmatrixAt(), oofem::TrPlaneStrRot::computeNmatrixAt(), oofem::Truss1d::computeNmatrixAt(), oofem::Truss2d::computeNmatrixAt(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::Lattice2d_mt::computeNSubMatrixAt(), oofem::Lattice3d_mt::computeNSubMatrixAt(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), 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_SUPG2::computePressureTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG::computePressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG2::computePressureTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG::computePressureTerm_MC(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MC(), oofem::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::Masonry02::computeReducedElasticModuli(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::DruckerPragerCutMat::computeReducedSKGradientMatrix(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::Masonry02::computeReducedSKGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::Masonry02::computeReducedSSGradientMatrix(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrxFromQuaternion(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::TR1_2D_SUPG::computeSlipWithFrictionBCTerm_MB(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::BaseMixedPressureElement::computeStiffnessMatrix(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::GradDpElement::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix(), oofem::Lattice2d::computeStiffnessMatrix(), oofem::Lattice2dBoundary::computeStiffnessMatrix(), oofem::Lattice3d::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3d::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix(), oofem::QPlaneStress2dSlip::computeStiffnessMatrix(), oofem::QTrPlaneStress2dSlip::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::SpringElement::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::CCTPlate3d::computeSurfaceNMatrixAt(), oofem::DKTPlate3d::computeSurfaceNMatrixAt(), oofem::TrPlaneStrRot3d::computeSurfaceNMatrixAt(), oofem::HTSelement::computeSvMatrixAt(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::ElementSide::computeTransformation(), oofem::BondLink3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundaryBeam::computeTransformationMatrix(), oofem::LIBeam3dBoundaryMembrane::computeTransformationMatrix(), oofem::LIBeam3dBoundaryPlate::computeTransformationMatrix(), oofem::LIBeam3dBoundaryTruss::computeTransformationMatrix(), oofem::LIBeam3dBoundaryVoigt::computeTransformationMatrix(), oofem::Line::computeTransformationMatrix(), oofem::LTRSpaceBoundary::computeTransformationMatrix(), oofem::LTRSpaceBoundaryBeam::computeTransformationMatrix(), oofem::LTRSpaceBoundaryMembrane::computeTransformationMatrix(), oofem::LTRSpaceBoundaryPlate::computeTransformationMatrix(), oofem::LTRSpaceBoundaryTruss::computeTransformationMatrix(), oofem::LTRSpaceBoundaryVoigt::computeTransformationMatrix(), oofem::IntElLine1::computeTransformationMatrixAt(), oofem::IntElLine1PF::computeTransformationMatrixAt(), oofem::IntElLine1PhF::computeTransformationMatrixAt(), oofem::IntElPoint::computeTransformationMatrixAt(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::DKTPlate::computeVertexBendingMoments(), oofem::TransportGradientDirichlet::computeXi(), oofem::LIBeam3dNL2::computeXMtrx(), oofem::LIBeam3dNL::computeXMtrx(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::deltaB(), oofem::BSplineInterpolation::dersBasisFuns(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::CrackExportModule::doOutput(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7Base::edgeComputeNmatrixAt(), oofem::FEI3dHexaConst::edgeEvaldNdx(), oofem::FEI3dHexaLin::edgeEvaldNdx(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::FEI3dLineLin::edgeEvaldNdx(), oofem::FEI3dTetLin::edgeEvaldNdx(), oofem::evalB(), oofem::FEI1dHermite::evald2Ndx2(), oofem::FEI2dTrQuad::evald2Ndx2(), oofem::FEI3dLineLin::evald2Ndx2(), oofem::BSplineInterpolation::evaldNdx(), oofem::FEI1dHermite::evaldNdx(), oofem::FEI1dLin::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::FEI2dQuadConst::evaldNdx(), oofem::FEI2dTrConst::evaldNdx(), oofem::FEI2dTrLin::evaldNdx(), oofem::FEI3dHexaConst::evaldNdx(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::FEI3dLineLin::evaldNdx(), oofem::FEI3dTetLin::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::NURBSInterpolation::evaldNdx(), oofem::TSplineInterpolation::evaldNdx(), oofem::FEI2dLineLin::evaldNdxi(), oofem::FEI2dLineQuad::evaldNdxi(), oofem::FEI2dQuadBiQuad::evaldNdxi(), oofem::FEI2dQuadQuad::evaldNdxi(), oofem::FEI2dTrQuad::evaldNdxi(), oofem::FEI3dHexaLin::evaldNdxi(), oofem::FEI3dHexaQuad::evaldNdxi(), oofem::FEI3dHexaTriQuad::evaldNdxi(), oofem::FEI3dTetQuad::evaldNdxi(), oofem::FEI3dWedgeLin::evaldNdxi(), oofem::FEI3dWedgeQuad::evaldNdxi(), oofem::BDalphaPiTerm::evaluate_lin(), oofem::NTaTmTe::evaluate_lin(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::VTKExportModule::exportCellVars(), fromArray(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase2D(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase3D(), oofem::VTKBaseExportModule::getCellVariableFromIS(), oofem::MisesMatGrad::give1dGprime(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::MisesMatGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::LayeredCrossSection::give3dShellRotStiffMtrx(), oofem::SimpleCrossSection::give3dShellRotStiffMtrx(), oofem::ExpCZMaterial::give3dStiffnessMatrix_Eng(), oofem::PFEMElement::giveCharacteristicMatrix(), oofem::PoissonElement::giveCharacteristicMatrix(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::SADGElement::giveCharacteristicMatrix(), oofem::SUPGElement2::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TMElement::giveCharacteristicMatrix(), oofem::TMSimpleMaterial::giveCharacteristicMatrix(), oofem::TR_SHELL01::giveCharacteristicMatrix(), oofem::TR_SHELL02::giveCharacteristicMatrix(), oofem::UPElement::giveCharacteristicMatrix(), oofem::UPSimpleMaterial::giveCharacteristicMatrix(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TR_SHELL11::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::IsotropicLinearElasticMaterial::giveDeviatoricPlaneStrainStiffMtrx(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::XMLInputRecord::giveField(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::StructuralMaterial::giveFullSymMatrixForm(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_BB(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_NB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_ud(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::MisesMatGrad::giveInternalLength(), oofem::RankineMatGrad::giveInternalLength(), oofem::TrabBoneGrad3D::giveInternalLength(), oofem::tet21ghostsolid::giveIPValue(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::FEI2dLineQuad::giveJacobianMatrixAt(), oofem::FEI3dHexaLin::giveJacobianMatrixAt(), oofem::FEI3dHexaQuad::giveJacobianMatrixAt(), oofem::FEI3dTetQuad::giveJacobianMatrixAt(), oofem::FEI3dWedgeLin::giveJacobianMatrixAt(), oofem::FEI3dWedgeQuad::giveJacobianMatrixAt(), oofem::FEInterpolation2d::giveJacobianMatrixAt(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::TSplineInterpolation::giveJacobianMatrixAt(), oofem::Shell7Base::giveL2contribution(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Beam2d::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::Lattice2d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dBoundary::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::Truss2d::giveLocalCoordinateSystem(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::Element::giveLocalCoordinateSystemVector(), oofem::FEI3dTrQuad::giveLocalNodeCoords(), oofem::FEI3dWedgeQuad::giveLocalNodeCoords(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::MazarsMaterial::giveNormalBlockOfElasticCompliance(), oofem::IDNLMaterial::giveNormalElasticStiffnessMatrix(), oofem::FCMMaterial::giveNormalLocalCrackedStiffnessMatrix(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::AnisotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::Shell7Base::giveRecoveredTransverseInterfaceStress(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::TR_SHELL01::giveRotationMatrix(), oofem::TR_SHELL02::giveRotationMatrix(), oofem::StructuralSlipFE2Material::giveSensitivities(), oofem::IntMatPhaseField::giveTangents(), oofem::FCMMaterial::giveTotalLocalCrackedStiffnessMatrix(), oofem::StrainVector::giveTranformationMtrx(), oofem::StressVector::giveTranformationMtrx(), oofem::BTamNTerm::grad(), oofem::BTSigmaTerm2::grad(), oofem::BTSigTerm::grad(), oofem::NTamTBTerm::grad(), oofem::Homogenize::herveZaoui(), oofem::MazarsMaterial::initDamaged(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::TransverseReinfConstraint::integrateTangent(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), jaco_(), oofem::TR1_2D_SUPG::LS_PCS_computedN(), oofem::ScalarAdvectionLhsAssembler::matrixFromElement(), oofem::SUPGTangentAssembler::matrixFromElement(), oofem::TMLhsAssembler::matrixFromElement(), oofem::UPLhsAssembler::matrixFromElement(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), plusDyadSymmUpper(), plusDyadUnsym(), plusProductSymmUpper(), plusProductUnsym(), oofem::Skyline::rbmodes(), oofem::OOFEMTXTInputRecord::readMatrix(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::ZZNodalRecoveryModel::recoverValues(), resizeWithData(), restoreYourself(), oofem::VTKXMLLatticeExportModule::setupVTKPieceCross(), oofem::GJacobi::solve(), oofem::InverseIteration::solve(), oofem::SLEPcSolver::solve(), oofem::SparseLinearSystemNM::solve(), oofem::SubspaceIteration::solve(), oofem::FEI2dLineLin::surfaceEvald2Ndxi2(), oofem::FEI3dQuadLin::surfaceEvald2Ndxi2(), oofem::FEI3dTrLin::surfaceEvald2Ndxi2(), oofem::FEI3dHexaConst::surfaceEvaldNdx(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEI3dTetLin::surfaceEvaldNdx(), oofem::FEI3dTetQuad::surfaceEvaldNdx(), oofem::FEI2dLineLin::surfaceEvaldNdxi(), oofem::FEI3dHexaLin::surfaceEvaldNdxi(), oofem::FEI3dQuadLin::surfaceEvaldNdxi(), oofem::FEI3dTrLin::surfaceEvaldNdxi(), oofem::FEI3dTrQuad::surfaceEvaldNdxi(), oofem::FEI3dQuadLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrQuad::surfaceGiveJacobianMatrixAt(), oofem::PetscSparseMtrx::times(), oofem::PetscSparseMtrx::timesT(), oofem::Skyline::toFloatMatrix(), oofem::SkylineUnsym::toFloatMatrix(), oofem::PrescribedDispSlipBCDirichletRC::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::ScalarAdvectionRhsAssembler::vectorFromElement(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix(), oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().
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 91 of file floatmatrix.C.
References at(), cols(), FloatMatrix(), oofem::min(), nColumns, nRows, resize(), rows(), and values.
Referenced by addSubVectorCol(), addSubVectorRow(), oofem::Element::computeDofTransformationMatrix(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::RVEStokesFlow::computeTangent3D(), oofem::BondLink3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundaryBeam::computeTransformationMatrix(), oofem::LIBeam3dBoundaryMembrane::computeTransformationMatrix(), oofem::LIBeam3dBoundaryPlate::computeTransformationMatrix(), oofem::LIBeam3dBoundaryTruss::computeTransformationMatrix(), oofem::LIBeam3dBoundaryVoigt::computeTransformationMatrix(), oofem::LTRSpaceBoundary::computeTransformationMatrix(), oofem::LTRSpaceBoundaryBeam::computeTransformationMatrix(), oofem::LTRSpaceBoundaryMembrane::computeTransformationMatrix(), oofem::LTRSpaceBoundaryPlate::computeTransformationMatrix(), oofem::LTRSpaceBoundaryTruss::computeTransformationMatrix(), oofem::LTRSpaceBoundaryVoigt::computeTransformationMatrix(), copySubVectorRow(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::FCMMaterial::giveRealStressVector(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressSteel(), and oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct().
| contextIOResultType oofem::FloatMatrix::restoreYourself | ( | DataStream & | stream | ) |
Definition at line 1909 of file floatmatrix.C.
References oofem::CIO_IOERR, oofem::CIO_OK, oofem::DataStream::read(), and resize().
Referenced by 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 \( a = r^{\mathrm{T}} \cdot a \cdot r\) .
| r | Transformation matrix. |
| mode | If set to 't' then the transpose of the rotation matrix is used instead. |
Definition at line 1612 of file floatmatrix.C.
References beProductOf(), beProductTOf(), beTProductOf(), FloatMatrix(), and OOFEM_ERROR.
Referenced by oofem::EngngModel::assemble(), oofem::EngngModel::assemble(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::AxisymElement::computeConstitutiveMatrix_dPdF_At(), oofem::PlaneStrainElement::computeConstitutiveMatrix_dPdF_At(), oofem::PlaneStressElement::computeConstitutiveMatrix_dPdF_At(), oofem::Structural3DElement::computeConstitutiveMatrix_dPdF_At(), oofem::AxisymElement::computeConstitutiveMatrixAt(), oofem::PlaneStrainElement::computeConstitutiveMatrixAt(), oofem::PlaneStressElement::computeConstitutiveMatrixAt(), oofem::Structural3DElement::computeConstitutiveMatrixAt(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Lattice2dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::LIBeam3dBoundary::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::StructuralInterfaceElement::computeTraction(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TR_SHELL11::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::Element::giveGlobalIPValue(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::DEIDynamic::solveYourselfAt(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::TR_SHELL01::ZZErrorEstimatorI_computeLocalStress(), and oofem::TR_SHELL02::ZZErrorEstimatorI_computeLocalStress().
|
inline |
Definition at line 129 of file floatmatrix.h.
References nRows.
Referenced by add(), add(), addProductOf(), addTProductOf(), assemble(), assignFloatMatrixF(), beInverseOf(), beProductOf(), beProductTOf(), oofem::FloatArray::beRowOf(), beSubMatrixOf(), beTProductOf(), beUnitMatrix(), changeComponentOrder(), checkBounds(), computeNorm(), oofem::FloatMatrixF< N, M >::FloatMatrixF(), fromArray(), fromCols(), fromIniList(), giveDeterminant(), giveNumberOfRows(), givePackSize(), giveTrace(), isAllFinite(), isNotEmpty(), isSquare(), operator<<, plusDyadSymmUpper(), plusDyadUnsym(), plusProductSymmUpper(), plusProductUnsym(), printYourself(), printYourself(), printYourselfToFile(), pY(), resize(), resizeWithData(), solveForRhs(), solveForRhs(), storeYourself(), subtract(), symmetrized(), and writeCSV().
| 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 641 of file floatmatrix.C.
References giveNumberOfColumns(), giveNumberOfRows(), oofem::FloatArray::giveSize(), and OOFEM_ERROR.
Referenced by oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::DKTPlate::computeVertexBendingMoments(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::FEI3dHexaLin::evaldNdx(), oofem::FEI3dHexaQuad::evaldNdx(), oofem::FEI3dTetQuad::evaldNdx(), oofem::FEI3dWedgeLin::evaldNdx(), oofem::FEI3dWedgeQuad::evaldNdx(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::MFrontUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::FEI3dHexaLin::giveJacobianMatrixAt(), oofem::FEI3dHexaQuad::giveJacobianMatrixAt(), oofem::FEI3dTetQuad::giveJacobianMatrixAt(), oofem::FEI3dWedgeLin::giveJacobianMatrixAt(), oofem::FEI3dWedgeQuad::giveJacobianMatrixAt(), oofem::StructuralSlipFE2Material::giveSensitivities(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), oofem::PLHoopStressCirc::propagateInterface(), oofem::InverseIteration::solve(), oofem::SparseLinearSystemNM::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 549 of file floatmatrix.C.
References FloatMatrix(), giveNumberOfColumns(), giveNumberOfRows(), and OOFEM_ERROR.
Referenced by oofem::ContactPair::compute_dNdxi_matrices(), oofem::FEContactPoint::compute_dNdxi_matrix(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::TransportElement::computeFlow(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeGtoLRotationMatrix(), oofem::TR_SHELL11::computeGtoLRotationMatrix(), oofem::ContactPair::computeNmatrix(), oofem::Shell7Base::giveLayerContributionToSR(), and oofem::Homogenize::herveZaoui().
| bool oofem::FloatMatrix::solveForRhs | ( | const FloatArray & | b, |
| FloatArray & | answer, | ||
| bool | transpose = false ) |
Solves the system of linear equations \( K\cdot a = b \) . 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 1303 of file floatmatrix.C.
References oofem::FloatArray::at(), at(), beTranspositionOf(), cols(), FloatMatrix(), oofem::FloatArray::givePointer(), givePointer(), oofem::IntArray::givePointer(), isSquare(), nRows, OOFEM_ERROR, rows(), oofem::FloatArray::size(), and oofem::transpose().
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::KelvinChainMaterial::computeCharCoefficients(), oofem::MaxwellChainMaterial::computeCharCoefficients(), oofem::TransportGradientNeumann::computeEta(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::LEPlic::doCellDLS(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FCMMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::FEI3dHexaConst::global2local(), oofem::FEI3dHexaLin::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::FEInterpolation2d::global2local(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::FluidMaterialEvaluator::solveYourself(), and oofem::StructuralMaterialEvaluator::solveYourself().
| bool oofem::FloatMatrix::solveForRhs | ( | const FloatMatrix & | B, |
| FloatMatrix & | answer, | ||
| bool | transpose = false ) |
Solves the system of linear equations \( K\cdot A = B \) . 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 1397 of file floatmatrix.C.
References at(), beTranspositionOf(), cols(), FloatMatrix(), giveNumberOfColumns(), givePointer(), oofem::IntArray::givePointer(), isSquare(), nRows, OOFEM_ERROR, rows(), and oofem::transpose().
| contextIOResultType oofem::FloatMatrix::storeYourself | ( | DataStream & | stream | ) | const |
Definition at line 1884 of file floatmatrix.C.
References oofem::CIO_IOERR, oofem::CIO_OK, cols(), and rows().
Referenced by oofem::MDM::packUnknowns().
| void oofem::FloatMatrix::subtract | ( | const FloatMatrix & | a | ) |
Subtracts matrix from the receiver.
| a | Matrix to be subtracted. |
Definition at line 1020 of file floatmatrix.C.
References _LOOP_MATRIX, cols(), FloatMatrix(), givePointer(), isNotEmpty(), negated(), OOFEM_ERROR, and rows().
Referenced by oofem::Shell7BaseXFEM::computeCohesiveNmatrixAt(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::Truss3dnl2::computeInitialStressStiffness(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::PrescribedDispSlipBCDirichletRC::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::operator-(), and oofem::operator-=().
| void oofem::FloatMatrix::symmetrized | ( | ) |
Initializes the lower half of the receiver according to the upper half.
Definition at line 1137 of file floatmatrix.C.
References at(), cols(), OOFEM_ERROR, and rows().
Referenced by oofem::TransportElement::computeBCSubMtrxAt(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::TransportElement::computeCapacitySubMatrix(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::Beam2d::computeConsistentMassMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::MDM::computeDamageTensor(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::SolidShell::computeGeometricStiffness(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::TransportElement::computeIntSourceLHSSubMatrix(), oofem::SUPGElement2::computeLSICStabilizationTerm_MB(), oofem::Quad10_2D_SUPG::computeLSICTerm(), oofem::TR21_2D_SUPG::computeLSICTerm(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::TR1_2D_SUPG_AXI::computePenetrationWithResistanceBCTerm_MB(), oofem::SUPGElement2::computePressureTerm_MC(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::TR1_2D_SUPG_AXI::computeSlipWithFrictionBCTerm_MB(), oofem::Beam2d::computeStiffnessMatrix(), oofem::Beam3d::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::MITC4Shell::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::StructuralElement::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Truss3dnl2::computeStiffnessMatrix(), oofem::Truss3dnl::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix_dd(), oofem::BaseMixedPressureElement::computeStiffnessMatrix_uu(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::GradientDamageElement::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::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::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 1155 of file floatmatrix.C.
References _LOOP_MATRIX.
Referenced by oofem::Truss3dnl2::_computeBmatrixAt(), add(), oofem::LinearConstraintBC::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedGradientBCWeak::assemble(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::Integral::assemble_lhs(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DGProblem::assembleDirichletBcRhsVector(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnTransferStress(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::ContactPair::compute_dNdxi_matrices(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::LTRSpaceBoundary::computeBHmatrixAt(), oofem::CCTPlate::computeBmatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::Lattice2dBoundary::computeBmatrixAt(), oofem::Lattice3d::computeBmatrixAt(), oofem::Lattice3dBoundary::computeBmatrixAt(), oofem::Lattice3dBoundaryTruss::computeBmatrixAt(), oofem::LTRSpaceBoundary::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::Truss2d::computeBmatrixAt(), oofem::Truss3dnl::computeBnlMatrixAt(), oofem::Lattice2d_mt::computeCapacityMatrix(), oofem::Lattice3d_mt::computeCapacityMatrix(), oofem::Shell7Base::computeCauchyStressVector(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Lattice2d_mt::computeConductivityMatrix(), oofem::Lattice3d_mt::computeConductivityMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::MDM::computeDamageTensor(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::SolidShell::computeEVector(), oofem::PrescribedGradientBCWeak::computeField(), oofem::Lattice2d_mt::computeGradientMatrixAt(), oofem::Lattice3d_mt::computeGradientMatrixAt(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Truss3dnl2::computeInitialStressStiffness(), oofem::Truss3dnl::computeInitialStressStiffness(), oofem::Beam2d::computeLumpedInitialStressMatrix(), oofem::Beam3d::computeLumpedInitialStressMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::Shell7Base::computeMassMatrix(), oofem::ContactPair::computeNmatrix(), oofem::HTSelement::computeOutwardNormalMatrix(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrxFromQuaternion(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::LatticeBeam3d::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Truss3dnl2::computeStiffnessMatrix(), oofem::Truss3dnl::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::TrPlanestressRotAllman::computeStiffnessMatrixZeroEnergyStabilization(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::PrescribedDispSlipBCDirichletRC::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::StructuralPenaltyContactBoundaryCondition::computeTangentFromContact(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::PrescribedDispSlipBCNeumannRC::computeWeightMatrix(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::FEI3dTetLin::evaldNdx(), oofem::deltaBTfiNpTerm::evaluate_lin(), oofem::NTcN::evaluate_lin(), oofem::NTmuVfSNTerm::evaluate_lin(), oofem::MisesMatGrad::give1dGprime(), oofem::IsotropicDamageMaterial::give1dStressStiffMtrx(), oofem::MisesMatGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::SADGElement::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TMSimpleMaterial::giveCharacteristicMatrix(), oofem::UPSimpleMaterial::giveCharacteristicMatrix(), oofem::TrPlaneStress2d::giveCharacteristicSize(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::IsotropicLinearElasticMaterial::giveDeviatoricPlaneStrainStiffMtrx(), oofem::RCSDEMaterial::giveEffectiveMaterialStiffnessMatrix(), oofem::RCSDMaterial::giveEffectiveMaterialStiffnessMatrix(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_BB(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_BN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_BN(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_du(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_NB(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_ud(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_ud(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_uu(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::IsotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::MisesMat::givePlaneStressStiffMtrx(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::IsotropicDamageMaterial::giveRealStressVector(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::IsotropicGradientDamageMaterial::giveRealStressVectorGradientDamage(), oofem::MPElement::integrateEdgeTerm_dw(), oofem::MPElement::integrateSurfaceTerm_dw(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressSteel(), oofem::MPElement::integrateTerm_dw(), oofem::EffectiveTangentAssembler::matrixFromEdgeLoad(), oofem::EffectiveTangentAssembler::matrixFromElement(), oofem::MidpointLhsAssembler::matrixFromElement(), oofem::ScalarAdvectionLhsAssembler::matrixFromElement(), oofem::SUPGTangentAssembler::matrixFromElement(), oofem::TMLhsAssembler::matrixFromElement(), oofem::UPLhsAssembler::matrixFromElement(), oofem::EffectiveTangentAssembler::matrixFromSurfaceLoad(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha2(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::operator*(), oofem::operator*(), oofem::operator*=(), oofem::ScalarAdvectionRhsAssembler::vectorFromElement(), 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 1586 of file floatmatrix.C.
| void oofem::FloatMatrix::zero | ( | ) |
Zeroes all coefficient of receiver.
Definition at line 1064 of file floatmatrix.C.
References _LOOP_MATRIX.
Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::PrescribedGradientBCWeak::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleExtraDisplock(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::ContactPair::compute_dNdxi_matrices(), oofem::TR1_2D_SUPG2::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MC(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::HTSelement::computeAMatrixAt(), oofem::TransportElement::computeBCMtrxAt(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::LTRSpaceBoundary::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::Quad1PlaneStrain::computeBHmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PFEMElement2d::computeBMatrix(), oofem::Quad10_2D_SUPG::computeBMatrix(), oofem::Tet1_3D_SUPG::computeBMatrix(), oofem::TR21_2D_SUPG::computeBMatrix(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::computeBmatrixAt(), oofem::BondLink3d::computeBmatrixAt(), oofem::CCTPlate::computeBmatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::DKTPlate::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElem2dQuad::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::Lattice2dBoundary::computeBmatrixAt(), oofem::Lattice3d::computeBmatrixAt(), oofem::Lattice3dBoundary::computeBmatrixAt(), oofem::Lattice3dBoundaryTruss::computeBmatrixAt(), oofem::LatticeLink3d::computeBmatrixAt(), oofem::LIBeam2d::computeBmatrixAt(), oofem::LIBeam2dNL::computeBmatrixAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::LIBeam3d::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::LSpace::computeBmatrixAt(), oofem::LSpaceBB::computeBmatrixAt(), oofem::LTRSpaceBoundary::computeBmatrixAt(), oofem::MITC4Shell::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::PlaneStress2d::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::QDKTPlate::computeBmatrixAt(), oofem::Quad1Mindlin::computeBmatrixAt(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::Quad1PlateSubSoil::computeBmatrixAt(), oofem::Quad2PlateSubSoil::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::tet21ghostsolid::computeBmatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::Tria1PlateSubSoil::computeBmatrixAt(), oofem::Tria2PlateSubSoil::computeBmatrixAt(), oofem::TrPlanestressRotAllman::computeBmatrixAt(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::Lattice2d_mt::computeCapacityMatrix(), oofem::Lattice3d_mt::computeCapacityMatrix(), oofem::TransportElement::computeCapacityMatrix(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Shell7BaseXFEM::computeCohesiveTangentAt(), oofem::Lattice2d_mt::computeConductivityMatrix(), oofem::Lattice3d_mt::computeConductivityMatrix(), oofem::TransportElement::computeConductivityMatrix(), oofem::TransportElement::computeConductivitySubMatrix(), oofem::AbaqusUserElement::computeConsistentMassMatrix(), oofem::Beam2d::computeConsistentMassMatrix(), oofem::Beam3d::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::TR1_2D_CBS::computeConsistentMassMtrx(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::Lattice3d::computeCrossSectionProperties(), oofem::Lattice3d_mt::computeCrossSectionProperties(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::MPlasticMaterial::computeDiagModuli(), oofem::PlasticMaterial::computeDiagModuli(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::Quad10_2D_SUPG::computeDivTauMatrix(), oofem::Tet1_3D_SUPG::computeDivTauMatrix(), oofem::TR21_2D_SUPG::computeDivTauMatrix(), oofem::Quad10_2D_SUPG::computeDivUMatrix(), oofem::Tet1_3D_SUPG::computeDivUMatrix(), oofem::TR21_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::Lattice3d_mt::computeGradientMatrixAt(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::Beam2d::computeGtoLRotationMatrix(), oofem::Beam3d::computeGtoLRotationMatrix(), oofem::BondLink3d::computeGtoLRotationMatrix(), oofem::BondLink3dBoundary::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::Lattice2d::computeGtoLRotationMatrix(), oofem::Lattice2dBoundary::computeGtoLRotationMatrix(), oofem::Lattice3d::computeGtoLRotationMatrix(), oofem::Lattice3dBoundary::computeGtoLRotationMatrix(), oofem::Lattice3dBoundaryTruss::computeGtoLRotationMatrix(), oofem::LatticeBeam3d::computeGtoLRotationMatrix(), oofem::LatticeBeam3dBoundary::computeGtoLRotationMatrix(), oofem::LatticeLink3d::computeGtoLRotationMatrix(), oofem::LatticeLink3dBoundary::computeGtoLRotationMatrix(), oofem::LIBeam2d::computeGtoLRotationMatrix(), oofem::LIBeam2dNL::computeGtoLRotationMatrix(), oofem::LIBeam3d2::computeGtoLRotationMatrix(), oofem::LIBeam3d::computeGtoLRotationMatrix(), oofem::LIBeam3dBoundary::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeGtoLRotationMatrix(), oofem::RerShell::computeGtoLRotationMatrix(), oofem::TR_SHELL11::computeGtoLRotationMatrix(), oofem::TrPlanestressRotAllman3d::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::J2MPlasticMaterial::computeHardeningReducedModuli(), oofem::J2plasticMaterial::computeHardeningReducedModuli(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Structural3DElement::computeInitialStressMatrix(), oofem::Truss3d::computeInitialStressMatrix(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::TransportElement::computeIntSourceLHSMatrix(), oofem::Node::computeL2GTransformation(), oofem::TR1_2D_SUPG2_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeLinearAdvectionTerm_MC(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::Beam3d::computeLoadGToLRotationMtrx(), oofem::CCTPlate3d::computeLoadGToLRotationMtrx(), oofem::DKTPlate3d::computeLoadGToLRotationMtrx(), oofem::LIBeam2d::computeLoadGToLRotationMtrx(), oofem::LIBeam2dNL::computeLoadGToLRotationMtrx(), oofem::LIBeam3d2::computeLoadGToLRotationMtrx(), oofem::LIBeam3d::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL2::computeLoadGToLRotationMtrx(), oofem::LIBeam3dNL::computeLoadGToLRotationMtrx(), oofem::LinQuad3DPlaneStress::computeLoadGToLRotationMtrx(), oofem::MITC4Shell::computeLoadGToLRotationMtrx(), oofem::TR_SHELL11::computeLoadGToLRotationMtrx(), oofem::TrPlanestressRotAllman3d::computeLoadGToLRotationMtrx(), oofem::TrPlaneStrRot3d::computeLoadGToLRotationMtrx(), oofem::CCTPlate::computeLoadLEToLRotationMatrix(), oofem::DKTPlate3d::computeLoadLEToLRotationMatrix(), oofem::DKTPlate::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::QDKTPlate::computeLoadLEToLRotationMatrix(), oofem::Quad1Mindlin::computeLoadLEToLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLoadLEToLRotationMatrix(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::Truss2d::computeLoadLEToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::TR1_2D_SUPG2::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG::computeLSICStabilizationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeLSICStabilizationTerm_MB(), oofem::Beam2d::computeLumpedInitialStressMatrix(), oofem::Beam3d::computeLumpedInitialStressMatrix(), oofem::CCTPlate::computeLumpedMassMatrix(), oofem::DKTPlate::computeLumpedMassMatrix(), oofem::InterfaceElem1d::computeLumpedMassMatrix(), oofem::Lattice3d::computeLumpedMassMatrix(), oofem::LIBeam2d::computeLumpedMassMatrix(), oofem::LIBeam2dNL::computeLumpedMassMatrix(), oofem::LIBeam3d2::computeLumpedMassMatrix(), oofem::LIBeam3d::computeLumpedMassMatrix(), oofem::LIBeam3dNL2::computeLumpedMassMatrix(), oofem::LIBeam3dNL::computeLumpedMassMatrix(), oofem::LTRSpace::computeLumpedMassMatrix(), oofem::LumpedMassElement::computeLumpedMassMatrix(), oofem::NodalSpringElement::computeLumpedMassMatrix(), oofem::Quad1Mindlin::computeLumpedMassMatrix(), oofem::Quad1MindlinShell3D::computeLumpedMassMatrix(), oofem::RerShell::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::Truss1d::computeLumpedMassMatrix(), oofem::Truss2d::computeLumpedMassMatrix(), oofem::Truss3d::computeLumpedMassMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::LIBeam2dNL::computeNLBMatrixAt(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::CCTPlate::computeNmatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::IntElPoint::computeNmatrixAt(), oofem::IntElSurfQuad1::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::LIBeam2d::computeNmatrixAt(), oofem::LIBeam2dNL::computeNmatrixAt(), oofem::LIBeam3d2::computeNmatrixAt(), oofem::LIBeam3d::computeNmatrixAt(), oofem::LIBeam3dNL2::computeNmatrixAt(), oofem::LIBeam3dNL::computeNmatrixAt(), oofem::MITC4Shell::computeNmatrixAt(), oofem::RerShell::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::TR_SHELL11::computeNmatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::TrPlanestressRotAllman::computeNmatrixAt(), oofem::TrPlaneStrRot::computeNmatrixAt(), oofem::Truss2d::computeNmatrixAt(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::Lattice2d_mt::computeNSubMatrixAt(), oofem::Lattice3d_mt::computeNSubMatrixAt(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::TR1_2D_SUPG::computeOutFlowBCTerm_MB(), oofem::HTSelement::computeOutwardNormalMatrix(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::TR1_2D_SUPG::computePenetrationWithResistanceBCTerm_MB(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::TR1_2D_SUPG2::computePressureTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG::computePressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG2::computePressureTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MC(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::DruckerPragerCutMat::computeReducedSKGradientMatrix(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::Masonry02::computeReducedSKGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::Masonry02::computeReducedSSGradientMatrix(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::TR1_2D_SUPG::computeSlipWithFrictionBCTerm_MB(), oofem::BaseMixedPressureElement::computeStiffnessMatrix(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::GradDpElement::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::HTSelement::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix(), oofem::Lattice2d::computeStiffnessMatrix(), oofem::Lattice2dBoundary::computeStiffnessMatrix(), oofem::Lattice3d::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3d::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix(), oofem::Quad1MindlinShell3D::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::StructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::CCTPlate3d::computeSurfaceNMatrixAt(), oofem::DKTPlate3d::computeSurfaceNMatrixAt(), oofem::TrPlaneStrRot3d::computeSurfaceNMatrixAt(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::StructuralPenaltyContactBoundaryCondition::computeTangentFromContact(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::ElementSide::computeTransformation(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::HTSelement::computeUgammaMatrixAt(), oofem::LIBeam3dNL2::computeXMtrx(), oofem::LIBeam3dNL::computeXMtrx(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::deltaB(), 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::FEI3dHexaConst::edgeEvaldNdx(), oofem::evalB(), oofem::FEI1dHermite::evald2Ndx2(), oofem::FEI3dLineLin::evald2Ndx2(), oofem::BSplineInterpolation::evaldNdx(), oofem::FEI1dHermite::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::FEI2dTrConst::evaldNdx(), oofem::FEI3dHexaConst::evaldNdx(), oofem::NURBSInterpolation::evaldNdx(), oofem::TSplineInterpolation::evaldNdx(), oofem::BDalphaPiTerm::evaluate_lin(), oofem::NTaTmTe::evaluate_lin(), oofem::VTKExportModule::exportCellVars(), oofem::VTKExportModule::exportIntVarAs(), oofem::MisesMatGrad::give1dGprime(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::MisesMatGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::LayeredCrossSection::give3dShellRotStiffMtrx(), oofem::SimpleCrossSection::give3dShellRotStiffMtrx(), oofem::ExpCZMaterial::give3dStiffnessMatrix_Eng(), oofem::PFEMElement::giveCharacteristicMatrix(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::SADGElement::giveCharacteristicMatrix(), oofem::SUPGElement2::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::TMElement::giveCharacteristicMatrix(), oofem::TMSimpleMaterial::giveCharacteristicMatrix(), oofem::TR_SHELL01::giveCharacteristicMatrix(), oofem::TR_SHELL02::giveCharacteristicMatrix(), oofem::UPElement::giveCharacteristicMatrix(), oofem::UPSimpleMaterial::giveCharacteristicMatrix(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TR_SHELL11::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::IsotropicLinearElasticMaterial::giveDeviatoricPlaneStrainStiffMtrx(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::StructuralMaterial::giveFullSymMatrixForm(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_dd_NN(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_NB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_ud(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::TSplineInterpolation::giveJacobianMatrixAt(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Beam2d::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::Lattice2d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dBoundary::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::Truss2d::giveLocalCoordinateSystem(), oofem::FEI3dTrQuad::giveLocalNodeCoords(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::MisesMatGrad::givePlaneStrainStiffMtrx(), oofem::AnisotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::StructuralSlipFE2Material::giveSensitivities(), oofem::IntMatPhaseField::giveTangents(), oofem::Shell7Base::giveTractionBC(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), oofem::ScalarAdvectionLhsAssembler::matrixFromElement(), oofem::SUPGTangentAssembler::matrixFromElement(), oofem::TMLhsAssembler::matrixFromElement(), oofem::UPLhsAssembler::matrixFromElement(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalRecoveryMI_computeNValProduct(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::Skyline::rbmodes(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SubspaceIteration::solve(), oofem::FEI3dHexaConst::surfaceEvaldNdx(), oofem::Skyline::toFloatMatrix(), oofem::SkylineUnsym::toFloatMatrix(), oofem::PrescribedDispSlipBCDirichletRC::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::ScalarAdvectionRhsAssembler::vectorFromElement(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().
|
friend |
Definition at line 2126 of file floatmatrix.C.
References cols(), FloatMatrix(), and rows().
|
staticconstexpr |
Definition at line 102 of file floatmatrix.h.
|
protected |
Number of columns.
Definition at line 97 of file floatmatrix.h.
Referenced by _resize_internal(), cols(), FloatMatrix(), FloatMatrix(), FloatMatrix(), FloatMatrix(), operator=(), operator=(), plus_Nt_a_otimes_b_B(), resize(), and resizeWithData().
|
protected |
Number of rows.
Definition at line 95 of file floatmatrix.h.
Referenced by _resize_internal(), beInverseOf(), FloatMatrix(), FloatMatrix(), FloatMatrix(), FloatMatrix(), operator()(), operator()(), operator=(), operator=(), plus_Nt_a_otimes_b_B(), resize(), resizeWithData(), rows(), solveForRhs(), and solveForRhs().
|
protected |
Values of matrix stored column wise.
Definition at line 99 of file floatmatrix.h.
Referenced by _resize_internal(), data(), data(), FloatMatrix(), FloatMatrix(), FloatMatrix(), FloatMatrix(), operator()(), operator()(), operator=(), operator=(), plus_Nt_a_otimes_b_B(), resize(), and resizeWithData().