OOFEM 3.0
Loading...
Searching...
No Matches
oofem::FloatArray Class Reference

#include <floatarray.h>

Inheritance diagram for oofem::FloatArray:

Public Member Functions

IML compatibility
FloatArrayoperator= (const double &)
 Assignment of scalar to all components of receiver.

Protected Attributes

std::vector< double > values
 Stored values.

Iterator for for-each loops:

typedef double Scalar
static constexpr int Dim = 1
class FloatMatrix
std::ostream & operator<< (std ::ostream &out, const FloatArray &x)
std::vector< double >::iterator begin ()
std::vector< double >::iterator end ()
std::vector< double >::const_iterator begin () const
std::vector< double >::const_iterator end () const
 FloatArray (int n=0)
 Constructor for sized array. Data is zeroed.
 FloatArray (double)=delete
 Disallow double parameter, which can otherwise give unexpected results.
 FloatArray (const FloatArray &src)
 Copy constructor. Creates the array from another array.
 FloatArray (FloatArray &&src) noexcept
 Move constructor. Creates the array from another array.
FloatArrayoperator= (const FloatArray &src)
 Assignment operator.
FloatArrayoperator= (FloatArray &&src) noexcept
 Move operator.
const double * data () const
double * data ()
double & operator() (Index i)
double & operator[] (Index i)
const double & operator() (Index i) const
const double & operator[] (Index i) const
void resize (Index s)
Index size () const
void _resize_internal (Index newsize)
 FloatArray (std ::initializer_list< double >list)
 Initializer list constructor.
template<std::size_t N>
 FloatArray (const FloatArrayF< N > &src)
virtual ~FloatArray ()
 Destructor.
FloatArrayoperator= (std ::initializer_list< double >list)
 Assignment operator.
template<std::size_t N>
FloatArrayoperator= (const FloatArrayF< N > &src)
 Assign from fixed size array.
bool isAllFinite () const
 Returns true if no element is NAN or infinite.
double & at (Index i)
double at (Index i) const
void checkBounds (Index i) const
void checkSizeTowards (const IntArray &loc)
void resizeWithValues (Index s, std::size_t allocChunk=0)
void clear ()
bool containsOnlyZeroes () const
Index giveSize () const
 Returns the size of receiver.
bool isNotEmpty () const
 Returns true if receiver is not empty.
bool isEmpty () const
 Returns true if receiver is empty.
void negated ()
virtual void printYourself () const
virtual void printYourself (const std::string &name) const
virtual void printYourselfToFile (const std::string filename, const bool showDimensions=true) const
virtual void pY () const
void zero ()
 Zeroes all coefficients of receiver.
void beProductOf (const FloatMatrix &aMatrix, const FloatArray &anArray)
void beTProductOf (const FloatMatrix &aMatrix, const FloatArray &anArray)
void beVectorProductOf (const FloatArray &v1, const FloatArray &v2)
void beScaled (double s, const FloatArray &b)
void add (const FloatArray &src)
void add (double factor, const FloatArray &b)
void plusProduct (const FloatMatrix &b, const FloatArray &s, double dV)
void add (double offset)
void subtract (const FloatArray &src)
void times (double s)
void beMaxOf (const FloatArray &a, const FloatArray &b)
void beMinOf (const FloatArray &a, const FloatArray &b)
void beDifferenceOf (const FloatArray &a, const FloatArray &b)
void beDifferenceOf (const FloatArray &a, const FloatArray &b, Index n)
void beSubArrayOf (const FloatArray &src, const IntArray &indx)
void addSubVector (const FloatArray &src, Index si)
void assemble (const FloatArray &fe, const IntArray &loc)
void assembleSquared (const FloatArray &fe, const IntArray &loc)
void copySubVector (const FloatArray &src, int si)
double distance (const FloatArray &x) const
double distance (const FloatArray *x) const
double distance (const FloatArray &iP1, const FloatArray &iP2, double &oXi, double &oXiUnbounded) const
double distance_square (const FloatArray &iP1, const FloatArray &iP2, double &oXi, double &oXiUnbounded) const
double distance_square (const FloatArray &x) const
int giveIndexMinElem (void)
int giveIndexMaxElem (void)
double dotProduct (const FloatArray &x) const
double dotProduct (const FloatArray &x, Index size) const
double normalize_giveNorm ()
void normalize ()
double computeNorm () const
double computeSquaredNorm () const
double sum () const
double product () const
void rotatedWith (FloatMatrix &r, char mode)
const double * givePointer () const
double * givePointer ()
void beVectorForm (const FloatMatrix &aMatrix)
void beSymVectorForm (const FloatMatrix &aMatrix)
void beSymVectorFormOfStrain (const FloatMatrix &aMatrix)
void changeComponentOrder ()
void power (const double exponent)
void beColumnOf (const FloatMatrix &mat, int col)
void beRowOf (const FloatMatrix &mat, Index row)
contextIOResultType storeYourself (DataStream &stream) const
contextIOResultType restoreYourself (DataStream &stream)
int givePackSize (DataStream &buff) const
static FloatArray fromVector (const std::vector< double > &v)
static FloatArray fromList (const std::list< double > &l)
static FloatArray fromConcatenated (std::initializer_list< FloatArray > ini)
static FloatArray fromIniList (std::initializer_list< double > ini)

Detailed Description

Class representing vector of real numbers. This array can grow or shrink to desired dimension. The lower value index of array is 1, upper depends on array size.

Tasks:

  • Storing and returning a coefficient (method 'at') ;
  • Expanding its size in order to store additional coefficients (method growTo )
  • Performing basic operations : summation, product, rotation, etc.
  • Assembling to itself another array, typically an elemental or nodal load vector (method 'assemble').
  • Reading/writing its description on a given file.
  • Introduced allocatedSize variable to allow dynamic resizing of array size possibly without memory reallocation. At startup array occupies space given by allocatedSpace = size. Then there can be
    • Further request for resizing array to smaller dimension then we only change size variable, but allocatedSize variable remain untouched - expecting possible array grow and then re-using previously allocated space.
    • If further request for growing then is necessary memory reallocation. This process is controlled in resize member function.

Remarks:

  • Method givePointer is an encapsulation crime. It is used only for speeding up method 'dot' of class RowColumn and for speeding method initialize.
Author
Mikael Öhman
Erik Svenning
Jim Brouzoulis
many others (please add yourselves)

Definition at line 88 of file floatarray.h.

Member Typedef Documentation

◆ Scalar

typedef double oofem::FloatArray::Scalar

Definition at line 114 of file floatarray.h.

Constructor & Destructor Documentation

◆ FloatArray() [1/6]

◆ FloatArray() [2/6]

oofem::FloatArray::FloatArray ( double )
delete

Disallow double parameter, which can otherwise give unexpected results.

◆ FloatArray() [3/6]

oofem::FloatArray::FloatArray ( const FloatArray & src)
inline

Copy constructor. Creates the array from another array.

Definition at line 121 of file floatarray.h.

References FloatArray(), and values.

◆ FloatArray() [4/6]

oofem::FloatArray::FloatArray ( FloatArray && src)
inlinenoexcept

Move constructor. Creates the array from another array.

Definition at line 123 of file floatarray.h.

References FloatArray(), and values.

◆ FloatArray() [5/6]

oofem::FloatArray::FloatArray ( std ::initializer_list< double > list)
inline

Initializer list constructor.

Definition at line 166 of file floatarray.h.

References fromIniList().

◆ FloatArray() [6/6]

template<std::size_t N>
oofem::FloatArray::FloatArray ( const FloatArrayF< N > & src)
inline

Definition at line 172 of file floatarray.h.

References oofem::FloatArrayF< N >::size(), and values.

◆ ~FloatArray()

virtual oofem::FloatArray::~FloatArray ( )
inlinevirtual

Destructor.

Definition at line 181 of file floatarray.h.

Member Function Documentation

◆ _resize_internal()

void oofem::FloatArray::_resize_internal ( Index newsize)

◆ add() [1/3]

void oofem::FloatArray::add ( const FloatArray & src)

Adds array src to receiver. If the receiver's size is zero, it adjusts its size to size of src array. If receiver's size is nonzero and different from src array size an error is generated.

Parameters
srcArray to add to receiver.

Definition at line 218 of file floatarray.C.

References FloatArray(), givePointer(), giveSize(), isEmpty(), OOFEM_ERROR, and size().

Referenced by oofem::Truss3dnl2::_computeBmatrixAt(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::HOMExportModule::average(), oofem::FloatMatrix::beLocalCoordSys(), oofem::Subdivision::RS_Tetra::bisect(), oofem::Subdivision::RS_Triangle::bisect(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::CylindricalALM::checkConvergence(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::SolidShell::computeAlpha(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubVectorAt(), oofem::TransportElement::computeBodyBCSubVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::FEContactSurface::computeContactPointLocalCoordinates_2d(), oofem::FEContactSurface::computeContactPointLocalCoordinates_3d(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::FEContactPoint::computeCurvature(), oofem::Truss3dnl2::computeDeformedLength(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::Hexa21Stokes::computeExternalForcesVector(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::Tet21Stokes::computeExternalForcesVector(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::Tr21Stokes::computeExternalForcesVector(), oofem::NonLinearStatic::computeExternalLoadReactionContribution(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGradientMultiple::computeField(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::IntElPoint::computeGlobalCoordinates(), oofem::LTRSpaceBoundary::computeGlobalCoordinates(), oofem::Shell7Base::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::Truss3dnl2::computeInitialStressStiffness(), oofem::Truss3dnl::computeInitialStressStiffness(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::TransportElement::computeInternalSourceRhsSubVectorAt(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::Lattice3d_mt::computeInternalSourceRhsVectorAt(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::PolygonLine::computeIntersectionPoints(), oofem::VTKBaseExportModule::computeIPAverage(), oofem::XfemStructuralElementInterface::computeIPAverageInTriangle(), oofem::BasicGeometry::computeLineDistance(), oofem::LatticeNeumannCouplingNode::computeLoadCouplingContribution(), oofem::LatticeNeumannCouplingNode::computeLoadVectorAt(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::PrescribedDispSlipMultiple::computeReinfStress(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::B3Material::computeShrinkageStrainVector(), oofem::LIBeam3d2::computeStrainVector(), oofem::PrescribedDispSlipMultiple::computeStress(), oofem::J2plasticMaterial::ComputeStressGradient(), oofem::J2Mat::computeStressGradientVector(), oofem::J2MPlasticMaterial::computeStressGradientVector(), oofem::RheoChainMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::PrescribedDispSlipMultiple::computeTransferStress(), oofem::TransportGradientDirichlet::computeXi(), oofem::J2Mat::computeYieldValueAt(), oofem::J2MPlasticMaterial::computeYieldValueAt(), oofem::J2plasticMaterial::computeYieldValueAt(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::CylindricalALM::do_lineSearch(), oofem::MITC4Shell::drawScalar(), oofem::TR_SHELL01::drawScalar(), oofem::TR_SHELL02::drawScalar(), oofem::Node::drawYourself(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::FEI3dHexaQuad::edgeGiveTransformationJacobian(), oofem::FEI3dTrQuad::edgeGiveTransformationJacobian(), oofem::FEI3dHexaQuad::edgeLocal2global(), oofem::FEI3dQuadLin::edgeLocal2global(), oofem::FEI3dTetQuad::edgeLocal2global(), oofem::FEI3dTrLin::edgeLocal2global(), oofem::FEI3dTrQuad::edgeLocal2global(), oofem::FEI3dWedgeLin::edgeLocal2global(), oofem::FEI3dWedgeQuad::edgeLocal2global(), oofem::DofManValueField::evaluateAt(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::VoxelVOFField::evaluateAt(), oofem::VTKExportModule::exportCellVars(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGenStrainShell7::give(), oofem::RotatingBoundary::give(), oofem::TransportGradientDirichlet::give(), oofem::PolygonLine::giveBoundingSphere(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::KelvinChainMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::MPSMaterial::giveEigenStrainVector(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::ContactBoundaryCondition::giveExportData(), oofem::PolygonLine::giveGlobalCoordinates(), oofem::Beam3d::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::SolidShell::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector_d(), oofem::PhaseFieldElement::giveInternalForcesVector_d(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::BaseMixedPressureElement::giveInternalForcesVector_u(), oofem::GradientDamageElement::giveInternalForcesVector_u(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::CoupledFieldsElement::giveInternalForcesVectorGen(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::AbaqusUserMaterial::giveIPValue(), oofem::MFrontUserMaterial::giveIPValue(), oofem::TR_SHELL01::giveIPValue(), oofem::TR_SHELL02::giveIPValue(), oofem::TwoFluidMaterial::giveIPValue(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::GradDpElement::giveNonlocalInternalForcesVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::LinearElasticMaterial::giveRealStressVector_1d(), oofem::LinearElasticMaterial::giveRealStressVector_2dBeamLayer(), oofem::LinearElasticMaterial::giveRealStressVector_Fiber(), oofem::LinearElasticMaterial::giveRealStressVector_PlaneStress(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::LinearElasticMaterial::giveRealStressVector_PlateLayer(), oofem::TrabBoneGrad3D::giveRealStressVectorGradientDamage(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::PolygonLine::giveSubPolygon(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::PrescribedGradientBCWeak::giveTractionElArcPos(), oofem::FEIElementDeformedGeometryWrapper::giveVertexCoordinates(), oofem::FEI3dHexaQuad::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::FEInterpolation2d::global2local(), oofem::MPElement::integrateEdgeTerm_c(), oofem::StokesFlowVelocityHomogenization::integrateNMatrix(), oofem::MPElement::integrateSurfaceTerm_c(), oofem::MPElement::integrateTerm_c(), oofem::MMAShapeFunctProjection::interpolateIntVarAt(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::BSplineInterpolation::local2global(), oofem::FEI3dHexaConst::local2global(), oofem::FEI3dHexaLin::local2global(), oofem::FEI3dHexaQuad::local2global(), oofem::FEI3dLineLin::local2global(), oofem::FEI3dQuadLin::local2global(), oofem::FEI3dTetLin::local2global(), oofem::FEI3dTetQuad::local2global(), oofem::FEI3dTrLin::local2global(), oofem::FEI3dTrQuad::local2global(), oofem::FEI3dWedgeLin::local2global(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::Q9PlaneStress2d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QPlaneStress2d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::NCPrincipalStrain::nucleateEnrichmentItems(), oofem::NCPrincipalStress::nucleateEnrichmentItems(), oofem::operator+(), oofem::operator+=(), oofem::MisesMat::performPlasticityReturn(), oofem::Triangle::pointIsInTriangle(), oofem::TR_SHELL02::printOutputAt(), oofem::GeometryBasedEI::propagateFronts(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::Triangle::refineTriangle(), oofem::Subdivision::smoothMesh(), oofem::CylindricalALM::solve(), oofem::DynamicRelaxationSolver::solve(), oofem::FETISolver::solve(), oofem::LineSearchNM::solve(), oofem::NRSolver::solve(), oofem::StaggeredSolver::solve(), oofem::CBS::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::TR_SHELL01::SpatialLocalizerI_giveBBox(), oofem::TR_SHELL02::SpatialLocalizerI_giveBBox(), oofem::FEI3dQuadLin::surfaceEvalBaseVectorsAt(), oofem::FEI3dTrLin::surfaceEvalBaseVectorsAt(), oofem::FEI3dTrQuad::surfaceEvalBaseVectorsAt(), oofem::FEI3dHexaLin::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceEvalNormal(), oofem::FEI3dHexaTriQuad::surfaceEvalNormal(), oofem::FEI3dTetQuad::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::FEI3dQuadLin::surfaceLocal2global(), oofem::FEI3dTetQuad::surfaceLocal2global(), oofem::FEI3dTrLin::surfaceLocal2global(), oofem::FEI3dTrQuad::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::OctantRecT< T > *::testBoundingBox(), oofem::Subdivision::unpackSharedIrregulars(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::SUPG::updateSolutionVectors(), oofem::DensityRhsAssembler::vectorFromElement(), oofem::IntermediateConvectionDiffusionAssembler::vectorFromElement(), oofem::TransportExternalForceAssembler::vectorFromElement(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), and oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay().

◆ add() [2/3]

void oofem::FloatArray::add ( double factor,
const FloatArray & b )

Adds array times factor to receiver. If the receiver's size is zero, it adjusts its size to size of b array. If receiver's size is nonzero and different from b array size an error is generated.

Parameters
factorFactor to be multiplied with b.
bWill be multiplied by factor and added to receiver.

Definition at line 260 of file floatarray.C.

References beScaled(), FloatArray(), givePointer(), giveSize(), isEmpty(), OOFEM_ERROR, and size().

◆ add() [3/3]

void oofem::FloatArray::add ( double offset)

Adds scalar to receiver.

Parameters
offsetScalar to add

Definition at line 252 of file floatarray.C.

◆ addSubVector()

void oofem::FloatArray::addSubVector ( const FloatArray & src,
Index si )

Adds the given vector as sub-vector to receiver. The sub-vector values will be added to receivers corresponding receiver's values at positions (si,...,si+src.size). The size of receiver will be adjusted, if necessary.

Parameters
srcSub-vector to be added.
siDetermines the position (receiver's 1-based index) of first src value to be added.

Definition at line 460 of file floatarray.C.

References FloatArray(), resizeWithValues(), and size().

◆ assemble()

void oofem::FloatArray::assemble ( const FloatArray & fe,
const IntArray & loc )

Assembles the array fe (typically, the load vector of a finite element) into the receiver, using loc as location array.

Parameters
feArray to be assembled.
locArray of code numbers. src(i) value will be added to receiver value at position loc(i) (if this loc(i) value is nonzero).

Definition at line 616 of file floatarray.C.

References at(), oofem::IntArray::at(), FloatArray(), giveSize(), oofem::IntArray::giveSize(), OOFEM_ERROR, size(), and oofem::IntArray::size().

Referenced by oofem::Integral::assemble_rhs(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DGProblem::assembleDirichletBcRhsVector(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::ContactBoundaryCondition::assembleExtrapolatedForces(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::MPElement::assembleTermContribution(), oofem::ContactBoundaryCondition::assembleVector(), oofem::LinearConstraintBC::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::TransverseReinfConstraint::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::EngngModel::assembleVectorFromElements(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorStress(), oofem::TR_SHELL01::computeBodyLoadVectorAt(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::TMElement::computeBoundaryEdgeLoadVector(), oofem::UPElement::computeBoundaryEdgeLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::TMElement::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::UPElement::computeBoundarySurfaceLoadVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::BaseMixedPressureElement::computeForceLoadVector(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::DofManager::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::PFEMElement::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::TMElement::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computePressureForceAt(), oofem::Shell7Base::computeSectionalForces(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::Shell7Base::computeTractionForce(), oofem::TransportGradientDirichlet::computeXi(), oofem::StressStrainBaseVector::convertToFullForm(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::Shell7Base::edgeGiveUpdatedSolutionVector(), oofem::PFEMElement::giveCharacteristicVector(), oofem::SUPGElement2::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::TR_SHELL01::giveCharacteristicVector(), oofem::TR_SHELL02::giveCharacteristicVector(), oofem::PrescribedMean::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::StructuralMaterial::giveFullSymVectorForm(), oofem::StructuralMaterial::giveFullVectorForm(), oofem::BaseMixedPressureElement::giveInternalForcesVector(), oofem::GradDpElement::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector(), oofem::IntElLine1PF::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::Shell7BaseXFEM::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Shell7Base::giveUpdatedSolutionVector(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::StaggeredSolver::solve(), oofem::PFEMPressureRhsAssembler::vectorFromElement(), oofem::ScalarAdvectionRhsAssembler::vectorFromElement(), oofem::SUPGInternalForceAssembler::vectorFromElement(), oofem::TMResidualAssembler::vectorFromElement(), and oofem::UPResidualAssembler::vectorFromElement().

◆ assembleSquared()

◆ at() [1/2]

double & oofem::FloatArray::at ( Index i)
inline

Coefficient access function. Returns value of coefficient at given position of the receiver. Provides 1-based indexing access.

Parameters
iPosition of coefficient in array.

Definition at line 202 of file floatarray.h.

References checkBounds().

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMALeastSquareProjection::__mapVariable(), oofem::Truss3dnl2::_computeStrainVector(), oofem::FEI2dQuadBiQuad::_evaldNdx(), oofem::SparseMtrx::addDiagonal(), oofem::WeakPeriodicBoundaryCondition::addElementSide(), oofem::FloatMatrix::addSubVectorCol(), oofem::FloatMatrix::addSubVectorRow(), oofem::PrimaryField::applyBoundaryCondition(), oofem::PrimaryField::applyBoundaryCondition(), oofem::SymmetryBarrier::applyConstraint(), oofem::NRSolver::applyConstraintsToLoadIncrement(), oofem::MDM::applyDamageToStiffness(), oofem::MDM::applyDamageTranformation(), oofem::PrimaryField::applyDefaultInitialCondition(), oofem::NonStationaryTransportProblem::applyIC(), oofem::PFEM::applyIC(), oofem::SUPG::applyIC(), oofem::PrimaryField::applyInitialCondition(), oofem::SparseNonLinearSystemNM::applyPerturbation(), assemble(), oofem::TransportElement::assembleLocalContribution(), assembleSquared(), oofem::LinearConstraintBC::assembleVector(), oofem::MixedGradientPressureDirichlet::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::HOMExportModule::average(), oofem::Skyline::backSubstitutionWith(), oofem::SkylineUnsym::backSubstitutionWith(), oofem::FloatMatrix::beDyadicProductOf(), oofem::FloatMatrix::beLocalCoordSys(), oofem::FloatMatrix::beMatrixForm(), oofem::FloatMatrix::beMatrixFormOfStress(), beProductOf(), beRowOf(), beSubArrayOf(), beTProductOf(), beVectorProductOf(), oofem::Subdivision::RS_Tetra::bisect(), oofem::FEInterpolation1d::boundaryEvalN(), oofem::DelaunayTriangulator::buildInitialBBXMesh(), oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::EnrichmentItem::calcPolarCoord(), oofem::PolylineNonlocalBarrier::calculateMinimumDistanceFromBoundary(), changeComponentOrder(), oofem::MacroLSpace::changeMicroBoundaryConditions(), oofem::BeamElementErrorCheckingRule::check(), oofem::ElementErrorCheckingRule::check(), oofem::ReactionErrorCheckingRule::check(), oofem::CylindricalALM::checkConvergence(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::CompoDamageMat::checkSnapBack(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::Delaunay::colinear(), oofem::Tensor2_3d::compute_dCm_dC_fromEigs(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::ContactElement::computeAABB(), 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_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::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MC(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::IDNLMaterial::computeAngleAndSigmaRatio(), oofem::FRCFCMNL::computeAngleBetweenVectors(), oofem::IntElLine1::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::MPSMaterial::computeAutogenousShrinkageDefinedByTF(), oofem::Triangle::computeBarycentrCoor(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue1D(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue2D(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::DelaunayTriangulator::computeBBXBasedOnNodeData(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::LTRSpaceBoundary::computeBHmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::Lattice2dBoundary::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::LTRSpaceBoundary::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::TR_SHELL11::computeBmatrixAt(), oofem::Tr_Warp::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBmatrixAt(), oofem::TransportElement::computeBodyBCSubVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::TR_SHELL11::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::TR21_2D_SUPG::computeCenterOf(), oofem::Triangle::computeCenterOfCircumCircle(), oofem::FreeWarping::computeCenterOfGravity(), oofem::B3SolidMaterial::computeCharCoefficients(), oofem::Eurocode2CreepMaterial::computeCharCoefficients(), oofem::KelvinChainMaterial::computeCharCoefficients(), oofem::MaxwellChainMaterial::computeCharCoefficients(), oofem::MPSMaterial::computeCharCoefficients(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeCohesiveNmatrixAt(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::TR21_2D_SUPG::computeCoordsOfEdge(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::TR1_2D_CBS::computeCorrectionRhs(), oofem::EnrichmentFront::computeCrackTangent(), oofem::TR1_2D_SUPG::computeCriticalLEPlicTimeStep(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::TR1_2D_CBS::computeCriticalTimeStep(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::Lattice3d::computeCrossSectionProperties(), oofem::Lattice3d_mt::computeCrossSectionProperties(), oofem::LatticeBeam3d::computeCrossSectionProperties(), oofem::RCSDEMaterial::computeCurrEquivStrain(), oofem::RCSDMaterial::computeCurrEquivStrain(), oofem::StructuralInterfaceElementPhF::computeDamageAt(), oofem::MDM::computeDamageOnPlane(), oofem::MazarsMaterial::computeDamageParam(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::GradDpElement::computeDeformationGradientVector(), oofem::GradientDamageElement::computeDeformationGradientVector(), oofem::LTRSpaceBoundary::computeDeformationGradientVector(), oofem::NLStructuralElement::computeDeformationGradientVector(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::tet21ghostsolid::computeDeformationGradientVectorFromDispl(), oofem::CylindricalALM::computeDeltaLambda(), oofem::TrabBoneMaterial::computeDensification(), oofem::TR1_2D_CBS::computeDensityRhsPressureTerms(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::TR1_2D_SUPG::computeDeviatoricStrain(), oofem::TR1_2D_CBS::computeDeviatoricStress(), oofem::TR1_2D_PFEM::computeDeviatoricStress(), oofem::TR1_2D_PFEM::computeDeviatoricStressDivergence(), oofem::StrainVector::computeDeviatoricVolumetricSplit(), oofem::StressVector::computeDeviatoricVolumetricSplit(), oofem::TR1_2D_CBS::computeDiagonalMassMtrx(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::RheoChainMaterial::computeDiscreteRelaxationFunction(), oofem::Line::computeDistanceTo(), oofem::ActiveDof::computeDofTransformation(), oofem::Dof::computeDofTransformation(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::SolidShell::computeEASBmatrixAt(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::DKTPlate::computeEdgeNMatrix(), oofem::QuadAxisym1_ht::computeEdgeVolumeAround(), oofem::TrAxisym1_ht::computeEdgeVolumeAround(), oofem::TrPlanestressRotAllman::computeEgdeNMatrixAt(), oofem::FRCFCMNL::computeElementCentroid(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IntMatIsoDamage::computeEquivalentJump(), oofem::Eurocode2CreepMaterial::computeEquivalentMaturity(), oofem::AnisotropicDamageMaterial::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::MazarsMaterial::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::RankineMat::computeEta(), oofem::SolidShell::computeEVector(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::Hexa21Stokes::computeField(), oofem::QTruss1dGradDamage::computeField(), oofem::Tet1BubbleStokes::computeField(), oofem::Tr1BubbleStokes::computeField(), oofem::Tr21Stokes::computeField(), oofem::Truss1dGradDamage::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::Lattice3d_mt::computeFlow(), oofem::RVEStokesFlow::computeFlux3D(), oofem::TMElement::computeFluxLBToLRotationMatrix(), oofem::UPElement::computeFluxLBToLRotationMatrix(), oofem::IntElLine1PF::computeFreeEnergy(), oofem::SolidShell::computeFVector(), oofem::BondLink3d::computeGeometryProperties(), oofem::BondLink3dBoundary::computeGeometryProperties(), oofem::Lattice3d::computeGeometryProperties(), oofem::Lattice3d_mt::computeGeometryProperties(), oofem::Lattice3dBoundary::computeGeometryProperties(), oofem::Lattice3dBoundaryTruss::computeGeometryProperties(), oofem::LatticeBeam3d::computeGeometryProperties(), oofem::LatticeBeam3dBoundary::computeGeometryProperties(), oofem::LatticeLink3d::computeGeometryProperties(), oofem::LatticeLink3dBoundary::computeGeometryProperties(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::Beam3d::computeGlobalCoordinates(), oofem::Beam3d::computeGlobalCoordinates(), oofem::CCTPlate3d::computeGlobalCoordinates(), oofem::DKTPlate3d::computeGlobalCoordinates(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::InterfaceElement3dTrLin::computeGlobalCoordinates(), oofem::Lattice2d::computeGlobalCoordinates(), oofem::Lattice2d_mt::computeGlobalCoordinates(), oofem::LIBeam2d::computeGlobalCoordinates(), oofem::LIBeam2dNL::computeGlobalCoordinates(), oofem::LIBeam3d2::computeGlobalCoordinates(), oofem::LIBeam3d::computeGlobalCoordinates(), oofem::LIBeam3dBoundary::computeGlobalCoordinates(), oofem::LIBeam3dNL2::computeGlobalCoordinates(), oofem::LIBeam3dNL::computeGlobalCoordinates(), oofem::LTRSpaceBoundary::computeGlobalCoordinates(), oofem::MITC4Shell::computeGlobalCoordinates(), oofem::Truss2d::computeGlobalCoordinates(), oofem::PlasticMaterial::ComputeGradientVector(), oofem::MPlasticMaterial::computeGradientVector(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::Tet1_3D_SUPG::computeGradUMatrix(), oofem::TR21_2D_SUPG::computeGradUMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::InterfaceElem2dLin::computeGtoLRotationMatrix(), oofem::InterfaceElem2dQuad::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::TR_SHELL11::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::TR1_2D_SUPG::computeHomogenizedReinforceTerm_MB(), oofem::TR1_2D_SUPG::computeHomogenizedReinforceTerm_MC(), oofem::Line::computeInclinationAngle(), oofem::Eurocode2CreepMaterial::computeIncrementOfAutogenousShrinkageVector(), oofem::Eurocode2CreepMaterial::computeIncrementOfDryingShrinkageVector(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Structural3DElement::computeInitialStressMatrix(), oofem::Truss3d::computeInitialStressMatrix(), oofem::Truss3dnl::computeInitialStressStiffness(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::TransportElement::computeInternalSourceRhsSubVectorAt(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::Lattice3d_mt::computeInternalSourceRhsVectorAt(), oofem::CemhydMat::computeInternalSourceVector(), oofem::HydratingConcreteMat::computeInternalSourceVector(), oofem::NlIsoMoistureMaterial::computeInternalSourceVector(), oofem::TR21_2D_SUPG::computeIntersection(), oofem::Circle::computeIntersectionPoints(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Line::computeIntersectionPoints(), oofem::PolygonLine::computeIntersectionPoints(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::J2Mat::computeJ2InvariantAt(), oofem::J2MPlasticMaterial::computeJ2InvariantAt(), oofem::J2plasticMaterial::computeJ2InvariantAt(), oofem::DruckerPragerCutMat::computeKGradientVector(), oofem::J2Mat::computeKGradientVector(), oofem::Masonry02::computeKGradientVector(), oofem::Shell7Base::computeLambdaNMatrix(), oofem::InterfaceElement3dTrLin::computeLCS(), oofem::LIBeam3dBoundary::computeLength(), oofem::TR1_2D_SUPG2_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeLinearAdvectionTerm_MC(), oofem::DKTPlate3d::computeLoadLEToLRotationMatrix(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::tet21ghostsolid::computeLoadVector(), oofem::TR1_2D_SUPG::computeLoadVector(), oofem::TR1_2D_SUPG_AXI::computeLoadVector(), oofem::CCTPlate3d::computeLocalCoordinates(), oofem::CCTPlate::computeLocalCoordinates(), oofem::DKTPlate3d::computeLocalCoordinates(), oofem::DKTPlate::computeLocalCoordinates(), oofem::Lattice2d_mt::computeLocalCoordinates(), oofem::Lattice3d_mt::computeLocalCoordinates(), oofem::MITC4Shell::computeLocalCoordinates(), oofem::QDKTPlate::computeLocalCoordinates(), oofem::RerShell::computeLocalCoordinates(), oofem::MDM::computeLocalDamageTensor(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::Beam2d::computeLumpedInitialStressMatrix(), oofem::Beam3d::computeLumpedInitialStressMatrix(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::RigidArmNode::computeMasterContribution(), oofem::TR21_2D_SUPG::computeMiddlePointOnParabolicArc(), oofem::LinearEdgeLoad::computeNArray(), oofem::XfemElementInterface::computeNCohesive(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::CCTPlate::computeNmatrixAt(), oofem::IntElLine1::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::TR_SHELL11::computeNmatrixAt(), oofem::TrPlanestressRotAllman::computeNmatrixAt(), oofem::TrPlaneStrRot::computeNmatrixAt(), oofem::Truss1d::computeNmatrixAt(), oofem::Truss2d::computeNmatrixAt(), oofem::TR1_2D_SUPG::computeNMtrx(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::FRCFCMNL::computeNonlocalStressInFibersInUncracked(), oofem::PolygonLine::computeNormalSignDist(), oofem::MicroplaneMaterial::computeNormalVolumetricStrainComponent(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::PhaseFieldElement::computeNStress_d(), oofem::Lattice2d_mt::computeNSubMatrixAt(), oofem::Lattice3d_mt::computeNSubMatrixAt(), oofem::TR1_2D_CBS::computeNumberOfNodalPrescribedTractionPressureContributions(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::WeakPeriodicBoundaryCondition::computeOrthogonalBasis(), oofem::TR1_2D_SUPG_AXI::computeOutFlowBCTerm_MB(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::TR1_2D_SUPG_AXI::computePenetrationWithResistanceBCTerm_MB(), oofem::AnisotropicDamageMaterial::computePlaneStressSigmaZ(), oofem::AnisotropicDamageMaterial::computePlaneStressStrain(), oofem::PerfectlyPlasticMaterial::computePlasticStiffnessAt(), oofem::B3SolidMaterial::computePointShrinkageStrainVector(), oofem::MPSMaterial::computePointShrinkageStrainVector(), oofem::MMALeastSquareProjection::computePolynomialTerms(), oofem::SPRNodalRecoveryModel::computePolynomialTerms(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::Shell7Base::computePressureForceAt(), 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::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::StrainVector::computePrincipalValues(), oofem::StressVector::computePrincipalValues(), oofem::StructuralMaterial::computePrincipalValues(), oofem::WeakPeriodicBoundaryCondition::computeProjectionCoefficient(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), oofem::TR21_2D_SUPG::computeQuadraticRoots(), oofem::LIBeam3dNL2::computeQuaternionFromRotMtrx(), oofem::QuadAxisym1_ht::computeRadiusAt(), oofem::TR1_2D_SUPG_AXI::computeRadiusAt(), oofem::TrAxisym1_ht::computeRadiusAt(), oofem::PrescribedDispSlipBCNeumannRC::computeRebarDyad(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedSKGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::PlasticMaterial::ComputeResidualVector(), oofem::MPlasticMaterial2::computeResidualVector(), oofem::MPlasticMaterial::computeResidualVector(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::DKTPlate::computeShearForces(), oofem::B3Material::computeShrinkageStrainVector(), oofem::TR1_2D_SUPG_AXI::computeSlipWithFrictionBCTerm_MB(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::Lattice3d_mt::computeSpecialCrossSectionProperties(), oofem::SpringElement::computeSpringInternalForce(), oofem::Lattice2dBoundary::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::DruckerPragerCutMat::computeStrainHardeningVarsIncrement(), oofem::J2Mat::computeStrainHardeningVarsIncrement(), oofem::Masonry02::computeStrainHardeningVarsIncrement(), oofem::IsotropicDamageMaterial1::computeStrainInvariants(), oofem::Lattice2dBoundary::computeStrainVector(), oofem::Lattice3dBoundary::computeStrainVector(), oofem::Lattice3dBoundaryTruss::computeStrainVector(), oofem::LatticeLink3dBoundary::computeStrainVector(), oofem::LIBeam3dNL2::computeStrainVector(), oofem::LIBeam3dNL::computeStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::MicroplaneMaterial::computeStrainVectorComponents(), oofem::Beam2d::computeStrainVectorInLayer(), oofem::CCTPlate::computeStrainVectorInLayer(), oofem::DKTPlate::computeStrainVectorInLayer(), oofem::LIBeam2d::computeStrainVectorInLayer(), oofem::LIBeam2dNL::computeStrainVectorInLayer(), oofem::QDKTPlate::computeStrainVectorInLayer(), oofem::RerShell::computeStrainVectorInLayer(), oofem::TR_SHELL11::computeStrainVectorInLayer(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::J2plasticMaterial::ComputeStressGradient(), oofem::DruckerPragerCutMat::computeStressGradientVector(), oofem::J2Mat::computeStressGradientVector(), oofem::J2MPlasticMaterial::computeStressGradientVector(), oofem::Masonry02::computeStressGradientVector(), oofem::RankinePlasticMaterial::computeStressGradientVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::SteelRelaxMat::computeStressRelaxationStrainVector(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVarsReducedGradient(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::InterfaceElem1d::computeStressVector(), oofem::LineDistributedSpring::computeStressVector(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::LIBeam3dNL::computeTempCurv(), oofem::Tensor2_3d::computeTensorPowerFromEigs(), oofem::Tensor2_3d::computeTensorPowerFromEigs(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::B3Material::computeTotalAverageShrinkageStrainVector(), oofem::B3SolidMaterial::computeTotalAverageShrinkageStrainVector(), oofem::Shell7Base::computeTractionForce(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::BondLink3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundaryMembrane::computeTransformationMatrix(), oofem::LIBeam3dBoundaryPlate::computeTransformationMatrix(), oofem::LIBeam3dBoundaryVoigt::computeTransformationMatrix(), oofem::LTRSpaceBoundary::computeTransformationMatrix(), oofem::LTRSpaceBoundaryBeam::computeTransformationMatrix(), oofem::LTRSpaceBoundaryMembrane::computeTransformationMatrix(), oofem::LTRSpaceBoundaryPlate::computeTransformationMatrix(), oofem::LTRSpaceBoundaryVoigt::computeTransformationMatrix(), oofem::IntElLine1PF::computeTransformationMatrixAt(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::LatticeDirichletCouplingNode::computeUnknownCouplingContribution(), oofem::BoundaryLoad::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::GravityPressure::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::TF1::computeValueAt(), oofem::UserDefinedTemperatureField::computeValueAt(), oofem::Load::computeValues(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::InterfaceElem2dLin::computeVolumeAround(), oofem::LTRSpaceBoundary::computeVolumeAround(), oofem::StressStrainBaseVector::computeVolumetricPart(), oofem::StructuralMaterial::computeVonMisesStress(), oofem::LIBeam3dNL2::computeXdVector(), oofem::LIBeam3dNL::computeXdVector(), oofem::TransportGradientDirichlet::computeXi(), oofem::DruckerPragerCutMat::computeYieldValueAt(), oofem::Masonry02::computeYieldValueAt(), oofem::RankinePlasticMaterial::computeYieldValueAt(), oofem::StructuralElement::condense(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), oofem::BoundingBox::contains(), oofem::OctantRecT< T > *::containsPoint(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::CylindricalALM::convertHPCMap(), oofem::SuperLUSolver::convertRhs(), oofem::SolutionbasedShapeFunction::copyDofManagersToSurfaceData(), oofem::FloatMatrix::copySubVectorRow(), oofem::FreemInterface::createInput(), oofem::TSplineInterpolation::createLocalKnotVector(), oofem::Subdivision::createMesh(), oofem::T3DInterface::createQCInterpolationMesh(), oofem::T3DInterface::createVTKExportMesh(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), distance_square(), oofem::OctantRecT< T > *::divideLocally(), oofem::CylindricalALM::do_lineSearch(), oofem::LEPlic::doCellDLS(), oofem::GPInitModule::doInit(), oofem::LEPlic::doLagrangianPhase(), oofem::CrackExportModule::doOutput(), oofem::DofManExportModule::doOutput(), oofem::HOMExportModule::doOutput(), oofem::VTKPFEMXMLExportModule::doOutput(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::MatlabExportModule::doOutputIntegrationPointFields(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::Lattice2dBoundary::drawDeformedGeometry(), oofem::Lattice3dBoundary::drawDeformedGeometry(), oofem::Lattice3dBoundaryTruss::drawDeformedGeometry(), oofem::LatticeBeam3dBoundary::drawDeformedGeometry(), oofem::LatticeLink3dBoundary::drawDeformedGeometry(), oofem::StructuralElementEvaluator::drawIGAPatchDeformedGeometry, oofem::Lattice2d::drawRawCrossSections(), oofem::Lattice2d_mt::drawRawCrossSections(), oofem::Lattice2dBoundary::drawRawCrossSections(), oofem::IGAElement::drawRawGeometry(), oofem::Lattice2dBoundary::drawRawGeometry(), oofem::Lattice3dBoundary::drawRawGeometry(), oofem::Lattice3dBoundaryTruss::drawRawGeometry(), oofem::LatticeBeam3dBoundary::drawRawGeometry(), oofem::LatticeLink3dBoundary::drawRawGeometry(), oofem::Axisymm3d::drawScalar(), oofem::Brick1_ht::drawScalar(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::CCTPlate::drawScalar(), oofem::CohesiveSurface3d::drawScalar(), oofem::DKTPlate::drawScalar(), oofem::IntElLine1::drawScalar(), oofem::IntElLine2::drawScalar(), oofem::IntElPoint::drawScalar(), oofem::InterfaceElem1d::drawScalar(), oofem::InterfaceElem2dLin::drawScalar(), oofem::InterfaceElem2dQuad::drawScalar(), oofem::L4Axisymm::drawScalar(), oofem::LIBeam3d2::drawScalar(), oofem::LSpace::drawScalar(), oofem::LTRSpace::drawScalar(), oofem::MITC4Shell::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::PlaneStress2d::drawScalar(), oofem::PlaneStress2dXfem::drawScalar(), oofem::QDKTPlate::drawScalar(), oofem::QPlaneStrain::drawScalar(), oofem::QPlaneStress2d::drawScalar(), oofem::QTrPlaneStrain::drawScalar(), oofem::QTrPlaneStress2d::drawScalar(), oofem::Quad10_2D_SUPG::drawScalar(), oofem::Quad1_ht::drawScalar(), oofem::Quad1PlaneStrain::drawScalar(), oofem::Tetrah1_ht::drawScalar(), oofem::TR1_2D_CBS::drawScalar(), oofem::TR1_2D_PFEM::drawScalar(), oofem::TR1_2D_SUPG2::drawScalar(), oofem::TR1_2D_SUPG2_AXI::drawScalar(), oofem::TR1_2D_SUPG::drawScalar(), oofem::TR21_2D_SUPG::drawScalar(), oofem::TR_SHELL01::drawScalar(), oofem::TR_SHELL02::drawScalar(), oofem::TrPlaneStrain::drawScalar(), oofem::TrPlaneStress2d::drawScalar(), oofem::TrPlaneStress2dXFEM::drawScalar(), oofem::Truss1d::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::Lattice2d::drawSpecial(), oofem::Lattice2dBoundary::drawSpecial(), oofem::LSpace::drawSpecial(), oofem::LTRSpace::drawSpecial(), oofem::PlaneStress2d::drawSpecial(), oofem::Quad1PlaneStrain::drawSpecial(), oofem::TrPlaneStress2d::drawSpecial(), oofem::Node::drawYourself(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::FEI2dLineConst::edgeComputeLength(), oofem::FEI2dLineLin::edgeComputeLength(), oofem::FEI2dQuadConst::edgeComputeLength(), oofem::FEI2dQuadLin::edgeComputeLength(), oofem::FEI2dTrConst::edgeComputeLength(), oofem::FEI2dTrLin::edgeComputeLength(), oofem::Shell7Base::edgeEvalCovarBaseVectorsAt(), oofem::FEI2dLineHermite::edgeEvald2Nds2(), oofem::FEI2dLineHermite::edgeEvaldNds(), oofem::FEI2dLineLin::edgeEvaldNds(), oofem::FEI2dLineQuad::edgeEvaldNds(), oofem::FEI2dQuadQuad::edgeEvaldNds(), oofem::FEI2dTrQuad::edgeEvaldNds(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::FEI3dTetLin::edgeEvaldNdx(), oofem::FEI3dTrQuad::edgeEvaldNdxi(), oofem::Shell7BaseXFEM::edgeEvalEnrCovarBaseVectorsAt(), oofem::Shell7Base::edgeEvalInitialCovarBaseVectorsAt(), oofem::FEI2dQuadLin::edgeEvalN(), oofem::FEI2dQuadQuad::edgeEvalN(), oofem::FEI2dTrConst::edgeEvalN(), oofem::FEI2dTrLin::edgeEvalN(), oofem::FEI2dTrQuad::edgeEvalN(), oofem::FEI3dHexaLin::edgeEvalN(), oofem::FEI3dHexaQuad::edgeEvalN(), oofem::FEI3dQuadLin::edgeEvalN(), oofem::FEI3dTetLin::edgeEvalN(), oofem::FEI3dTrLin::edgeEvalN(), oofem::FEI3dTrQuad::edgeEvalN(), oofem::FEI3dWedgeLin::edgeEvalN(), oofem::FEI3dWedgeQuad::edgeEvalN(), oofem::FEI2dLineConst::edgeEvalNormal(), oofem::FEI2dLineHermite::edgeEvalNormal(), oofem::FEI2dLineLin::edgeEvalNormal(), oofem::FEI2dLineQuad::edgeEvalNormal(), oofem::FEI2dQuadLin::edgeEvalNormal(), oofem::FEI2dQuadQuad::edgeEvalNormal(), oofem::FEI2dTrLin::edgeEvalNormal(), oofem::FEI2dTrQuad::edgeEvalNormal(), oofem::FEI2dQuadLinAxi::edgeGiveTransformationJacobian(), oofem::FEI2dQuadQuadAxi::edgeGiveTransformationJacobian(), oofem::FEI2dTrLinAxi::edgeGiveTransformationJacobian(), oofem::FEI3dHexaQuad::edgeGiveTransformationJacobian(), oofem::FEI3dTrQuad::edgeGiveTransformationJacobian(), oofem::FEI2dQuadLin::edgeLocal2global(), oofem::FEI2dQuadQuad::edgeLocal2global(), oofem::FEI2dTrConst::edgeLocal2global(), oofem::FEI2dTrLin::edgeLocal2global(), oofem::FEI2dTrQuad::edgeLocal2global(), oofem::FEI3dHexaLin::edgeLocal2global(), oofem::FEI3dHexaQuad::edgeLocal2global(), oofem::FEI3dTetLin::edgeLocal2global(), oofem::FEI3dWedgeLin::edgeLocal2global(), oofem::FEI3dWedgeQuad::edgeLocal2global(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::tet21ghostsolid::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::Tet21Stokes::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::ZZErrorEstimator::estimateError(), oofem::Parser::eval(), oofem::ScalarFunction::eval(), oofem::FEI1dHermite::evald2Ndx2(), oofem::FEI2dTrQuad::evald2Ndx2(), oofem::FEI1dHermite::evaldNdx(), oofem::FEI1dLin::evaldNdx(), oofem::FEI1dLin::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::FEI2dLineHermite::evaldNdx(), oofem::FEI2dQuadLin::evaldNdx(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI2dTrLin::evaldNdx(), oofem::FEI2dTrLin::evaldNdx(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI3dLineLin::evaldNdx(), oofem::FEI3dTetLin::evaldNdx(), oofem::FEI3dTetLin::evaldNdx(), 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::BSplineInterpolation::evalN(), oofem::FEI1dHermite::evalN(), oofem::FEI1dLin::evalN(), oofem::FEI1dQuad::evalN(), oofem::FEI2dLineConst::evalN(), oofem::FEI2dLineHermite::evalN(), oofem::FEI2dLineLin::evalN(), oofem::FEI2dQuadBiQuad::evalN(), oofem::FEI2dQuadConst::evalN(), oofem::FEI2dQuadQuad::evalN(), oofem::FEI2dTrLin::evalN(), oofem::FEI2dTrQuad::evalN(), oofem::FEI3dHexaQuad::evalN(), oofem::FEI3dHexaTriQuad::evalN(), oofem::FEI3dLineLin::evalN(), oofem::FEI3dTetLin::evalN(), oofem::FEI3dWedgeLin::evalN(), oofem::FEI3dWedgeQuad::evalN(), oofem::NURBSInterpolation::evalN(), oofem::FEI2dLineConst::evalNXIntegral(), oofem::FEI2dLineLin::evalNXIntegral(), oofem::FEI2dLineQuad::evalNXIntegral(), oofem::FEI2dQuadLin::evalNXIntegral(), oofem::FEI2dQuadQuad::evalNXIntegral(), oofem::FEI2dTrLin::evalNXIntegral(), oofem::FEI2dTrQuad::evalNXIntegral(), oofem::FEI3dTetLin::evalNXIntegral(), oofem::CalculatorFunction::evaluate(), oofem::ElementCircumCirclesContainingNode::evaluate(), oofem::InsertNode::evaluate(), oofem::InsertTriangleBasedOnCircumcircle::evaluate(), oofem::InterpolatingFuction::evaluate(), oofem::NTaTmTe::evaluate(), oofem::dnTaN::evaluate_lin(), oofem::DofManValueField::evaluateAt(), oofem::ExpressionField::evaluateAt(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::UnstructuredGridField::evaluateAt(), oofem::Function::evaluateAtTime(), oofem::Delamination::evaluateEnrFuncAt(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncAt(), oofem::EnrFrontIntersection::evaluateEnrFuncAt(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncAt(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncAt(), oofem::RampFunction::evaluateEnrFuncDerivAt(), oofem::DamagedNeighborLayered::evaluateFailureCriteria(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::CohesiveSurface3d::evaluateLocalCoordinateSystem(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::RankineMat::evaluatePlaneStressStiffMtrx(), oofem::RankineMat::evalYieldFunction(), oofem::VTKExportModule::exportCellVars(), oofem::VTKBaseExportModule::exportExternalForces(), oofem::POIExportModule::exportIntVarAs(), oofem::VTKExportModule::exportIntVarAs(), oofem::POIExportModule::exportIntVars(), oofem::VTKXMLLatticeExportModule::exportPrimaryVars(), oofem::VTKXMLPeriodicExportModule::exportPrimaryVars(), oofem::VTKExportModule::exportPrimVarAs(), oofem::HuertaErrorEstimator::extractVectorFrom(), oofem::SkylineUnsym::factorized(), oofem::Beam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LIBeam3d2::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LIBeam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LEPlic::findCellLineConstant(), oofem::QClinearStatic::findNearestParticle(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::LevelSetPCS::FMMReinitialization(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase2D(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase3D(), oofem::RheoChainMaterial::generateLogTimeScale(), oofem::VTKBaseExportModule::getCellVariableFromIS(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKBaseExportModule::getNodalVariableFromIS(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLXFemExportModule::getNodalVariableFromXFEMST(), oofem::BeamElementErrorCheckingRule::getValue(), oofem::ElementErrorCheckingRule::getValue(), oofem::ReactionErrorCheckingRule::getValue(), oofem::Parser::getVariableValue(), oofem::InitialCondition::give(), oofem::InteractionBoundaryCondition::give(), oofem::PrescribedDispSlipBCDirichletRC::give(), oofem::PrescribedGenStrainShell7::give(), oofem::PrescribedGradient::give(), oofem::RotatingBoundary::give(), oofem::MisesMatGrad::give1dGprime(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::AnisotropicDamageMaterial::give1dStressStiffMtrx(), oofem::IsotropicAsymmetric1DMaterial::give1dStressStiffMtrx(), oofem::MisesMat::give1dStressStiffMtrx(), oofem::MisesMatGrad::give1dStressStiffMtrx(), oofem::HyperelasticMaterial1d::give1dStressStiffnessMatrix_dPdF(), oofem::IntMatIsoDamage::give2dStiffnessMatrix_Eng(), oofem::MisesMatGrad::give3dGprime(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::AnisotropicDamageMaterial::give3dMaterialStiffnessMatrix(), oofem::MFrontUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::SimpleInterfaceMaterial::give3dStiffnessMatrix_Eng(), oofem::FEI2dQuadLin::giveArea(), oofem::FEI2dQuadQuad::giveArea(), oofem::FEI2dTrLin::giveArea(), oofem::FEI2dTrQuad::giveArea(), oofem::FEI3dTrQuad::giveArea(), oofem::RerShell::giveArea(), oofem::TR_SHELL11::giveArea(), oofem::TrPlaneStrRot::giveArea(), oofem::Shell7BaseXFEM::giveAverageTransverseInterfaceStress(), oofem::UnstructuredGridField::Cell::giveBoundingBox(), oofem::Element::giveCharacteristicLengthForAxisymmElements(), oofem::Element::giveCharacteristicLengthForPlaneElements(), 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::CompoDamageMat::giveCharLengthForModes(), oofem::OctantRecT< T > *::giveChildContainingPoint(), oofem::DofManager::giveCompleteUnknownVector(), oofem::Beam3d::giveCompositeExportData(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::DofManager::giveCoordinate(), oofem::Lattice2d::giveCrossSectionCoordinates(), oofem::Lattice2d_mt::giveCrossSectionCoordinates(), oofem::Lattice2dBoundary::giveCrossSectionCoordinates(), oofem::LIBeam3d2::giveCurrentLength(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::FEI3dTrLin::giveDerivativeEta(), oofem::FEI3dTrQuad::giveDerivativeEta(), oofem::TR_SHELL11::GiveDerivativeUX(), oofem::TrPlaneStrRot::GiveDerivativeUX(), oofem::TR_SHELL11::GiveDerivativeUY(), oofem::TrPlaneStrRot::GiveDerivativeUY(), oofem::TR_SHELL11::GiveDerivativeVX(), oofem::TrPlaneStrRot::GiveDerivativeVX(), oofem::TR_SHELL11::GiveDerivativeVY(), oofem::TrPlaneStrRot::GiveDerivativeVY(), oofem::FEI3dTrLin::giveDerivativeXi(), oofem::FEI3dTrQuad::giveDerivativeXi(), oofem::DelaunayTriangle::giveDistanceToCenter(), oofem::Shell7BaseXFEM::giveDisUnknownsAt(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::BinghamFluidMaterial2::giveEffectiveViscosity(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::LEPlic::giveElementMaterialMixture(), oofem::LevelSetPCS::giveElementMaterialMixture(), oofem::IntElPoint::giveEngTraction(), oofem::ExpCZMaterial::giveEngTraction_3d(), oofem::ContactBoundaryCondition::giveExportData(), oofem::PrescribedMean::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::Shell7Base::giveFictiousCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedNodeCoordsForExport(), oofem::OOFEMTXTInputRecord::giveField(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::TransportMaterial::giveFluxVector(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::Shell7Base::giveGeneralizedStrainComponents(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam2d(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_MembraneRot(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::SimpleCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::SimpleCrossSection::giveGeneralizedStress_Shell(), oofem::LayeredCrossSection::giveGeneralizedStress_ShellRot(), oofem::SimpleCrossSection::giveGeneralizedStress_ShellRot(), oofem::Element::giveGlobalIPValue(), oofem::Lattice2d::giveGpCoordinates(), oofem::Lattice2d_mt::giveGpCoordinates(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_NB(), oofem::B3SolidMaterial::giveHumidity(), oofem::MPSMaterial::giveHumidity(), oofem::B3SolidMaterial::giveHumidityIncrement(), oofem::AnisotropicLinearElasticMaterial::giveInputRecord(), oofem::Element::giveInputRecord(), oofem::PolygonLine::giveInputRecord(), oofem::LayeredCrossSection::giveInterfaceXiCoords(), oofem::Lattice2dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeBeam3d::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::LIBeam3dNL2::giveInternalForcesVector(), oofem::LIBeam3dNL::giveInternalForcesVector(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::NodalSpringElement::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::QPlaneStress2dSlip::giveInternalForcesVector(), oofem::QTrPlaneStress2dSlip::giveInternalForcesVector(), oofem::SpringElement::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector_d(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::CBSElement::giveInternalStateAtNode(), oofem::Element::giveInternalStateAtNode(), oofem::PFEMElement::giveInternalStateAtNode(), oofem::StructuralElement::giveInternalStateAtNode(), oofem::SUPGElement2::giveInternalStateAtNode(), oofem::SUPGElement::giveInternalStateAtNode(), oofem::TR1_2D_CBS::giveInternalStateAtNode(), oofem::TR1_2D_PFEM::giveInternalStateAtNode(), oofem::TransportElement::giveInternalStateAtNode(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::Beam2d::giveIPValue(), oofem::Beam3d::giveIPValue(), oofem::BondCEBMaterial::giveIPValue(), oofem::CCTPlate3d::giveIPValue(), oofem::CCTPlate::giveIPValue(), oofem::CebFipSlip90Material::giveIPValue(), oofem::CemhydMat::giveIPValue(), oofem::ConcreteDPM2::giveIPValue(), oofem::ConcreteDPM::giveIPValue(), oofem::ConcreteFCM::giveIPValue(), oofem::ConcreteFCMViscoElastic::giveIPValue(), oofem::CrossSection::giveIPValue(), oofem::DKTPlate3d::giveIPValue(), oofem::DKTPlate::giveIPValue(), oofem::DruckerPragerPlasticitySM::giveIPValue(), oofem::DustMaterial::giveIPValue(), oofem::Element::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::FluidDynamicMaterial::giveIPValue(), oofem::FRCFCM::giveIPValue(), oofem::FRCFCMNL::giveIPValue(), oofem::HeMoBazNajMaterial::giveIPValue(), oofem::HeMoKunzelMaterial::giveIPValue(), oofem::HeMoTKMaterial::giveIPValue(), oofem::HydratingConcreteMat::giveIPValue(), oofem::HydratingHeMoMaterial::giveIPValue(), oofem::HydratingIsoHeatMaterial::giveIPValue(), oofem::IDNLMaterial::giveIPValue(), oofem::IntMatIsoDamage::giveIPValue(), oofem::IsoInterfaceDamageMaterial::giveIPValue(), oofem::IsoInterfaceDamageMaterial_2::giveIPValue(), oofem::IsotropicDamageMaterial::giveIPValue(), oofem::IsotropicHeatTransferMaterial::giveIPValue(), oofem::IsotropicMoistureTransferMaterial::giveIPValue(), oofem::LatticeCrossSection::giveIPValue(), oofem::LatticeDamage::giveIPValue(), oofem::LatticePlasticityDamage::giveIPValue(), oofem::LatticeSlip::giveIPValue(), oofem::LayeredCrossSection::giveIPValue(), oofem::LinearElasticMaterial::giveIPValue(), oofem::LinQuad3DPlaneStress::giveIPValue(), oofem::M1Material::giveIPValue(), oofem::Material::giveIPValue(), oofem::MDM::giveIPValue(), oofem::MisesMat::giveIPValue(), oofem::MPSDamMaterial::giveIPValue(), oofem::MPSMaterial::giveIPValue(), oofem::QDKTPlate::giveIPValue(), oofem::Quad10_2D_SUPG::giveIPValue(), oofem::Quad1Mindlin::giveIPValue(), oofem::Quad1MindlinShell3D::giveIPValue(), oofem::Quad1PlateSubSoil::giveIPValue(), oofem::RankineMat::giveIPValue(), oofem::RankineMatGrad::giveIPValue(), oofem::RankineMatNl::giveIPValue(), oofem::RCM2Material::giveIPValue(), oofem::RerShell::giveIPValue(), oofem::RheoChainMaterial::giveIPValue(), oofem::RVEStokesFlow::giveIPValue(), oofem::SimpleCrossSection::giveIPValue(), oofem::StructuralInterfaceCrossSection::giveIPValue(), oofem::StructuralInterfaceMaterial::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::tet21ghostsolid::giveIPValue(), oofem::TR1_2D_CBS::giveIPValue(), oofem::TR1_2D_SUPG2::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::TR_SHELL11::giveIPValue(), oofem::TrabBone3D::giveIPValue(), oofem::TrabBoneEmbed::giveIPValue(), oofem::TrPlanestressRotAllman3d::giveIPValue(), oofem::TrPlaneStrRot3d::giveIPValue(), oofem::TrPlaneStrRot::giveIPValue(), oofem::Truss3d::giveIPValue(), oofem::J2Mat::giveIsotropicHardeningVar(), oofem::J2MPlasticMaterial::giveIsotropicHardeningVar(), oofem::J2plasticMaterial::giveIsotropicHardeningVar(), oofem::FEI2dLineQuad::giveJacobianMatrixAt(), oofem::LatticeLinearElastic::giveLatticeStress3d(), oofem::LayeredCrossSection::giveLayer(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::LayeredCrossSection::giveLayerMidZ(), oofem::LayeredCrossSection::giveLayerThickness(), oofem::FEI1dHermite::giveLength(), oofem::FEI1dLin::giveLength(), oofem::FEI1dQuad::giveLength(), oofem::FEI2dLineHermite::giveLength(), oofem::Lattice2dBoundary::giveLength(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dBoundary::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::Shell7BaseXFEM::giveLocalCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveLocalNodeCoordsForExport(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::Shell7Base::giveMassFactorsAt(), oofem::LEPlic::giveMaterialMixtureAt(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::Shell7BaseXFEM::giveMaxCZDamages(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::CCTPlate3d::giveNodeCoordinates(), oofem::CCTPlate::giveNodeCoordinates(), oofem::DKTPlate3d::giveNodeCoordinates(), oofem::DKTPlate::giveNodeCoordinates(), oofem::QDKTPlate::giveNodeCoordinates(), oofem::TR_SHELL11::giveNodeCoordinates(), oofem::TrPlaneStrRot3d::giveNodeCoordinates(), oofem::TrPlaneStrRot::giveNodeCoordinates(), oofem::PrescribedDispSlipBCDirichletRC::giveOnConcrete(), oofem::PrescribedDispSlipBCDirichletRC::giveOnSteel(), oofem::TR_SHELL11::GivePitch(), oofem::TrPlaneStrRot::GivePitch(), oofem::Lattice2dBoundary::givePitch(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainKappaMatrix(), oofem::AnisotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::MisesMat::givePlaneStressStiffMtrx(), oofem::DofManager::givePrescribedUnknownVector(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::LatticeLinearElastic::giveRandomParameters(), oofem::MDM::giveRawMDMParameters(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::FRCFCMNL::giveRealStressVector(), oofem::IsotropicDamageMaterial::giveRealStressVector(), oofem::MDM::giveRealStressVector(), oofem::MPlasticMaterial2::giveRealStressVector(), oofem::MPlasticMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::M1Material::giveRealStressVector_3d(), oofem::MicroplaneMaterial_Bazant::giveRealStressVector_3d(), oofem::AnisotropicDamageMaterial::giveRealStressVector_PlaneStress(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::IsotropicLinearElasticMaterial::giveRealStressVectorUP_3d(), oofem::IsotropicLinearElasticMaterial::giveRealStressVectorUP_PlaneStrain(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::StructuralSlipFE2Material::giveSensitivities(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::LayeredCrossSection::giveSlaveGaussPoint(), oofem::Shell7Base::giveSPRcontribution(), oofem::J2Mat::giveStressBackVector(), oofem::J2MPlasticMaterial::giveStressBackVector(), oofem::J2plasticMaterial::giveStressBackVector(), oofem::PerfectlyPlasticMaterial::GiveStressCorrectionBackToYieldSurface(), oofem::Skyline::giveSubMatrix(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::MisesMat::giveTemperature(), oofem::MPSMaterial::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::TwoFluidMaterial::giveTempVOF(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::QuadAxisym1_ht::giveThicknessAt(), oofem::TrAxisym1_ht::giveThicknessAt(), oofem::PolygonLine::giveTips(), oofem::FEI1dLin::giveTransformationJacobian(), oofem::FEI1dQuad::giveTransformationJacobian(), oofem::FEI2dLineConst::giveTransformationJacobian(), oofem::FEI2dLineHermite::giveTransformationJacobian(), oofem::FEI2dLineLin::giveTransformationJacobian(), oofem::FEI2dLineQuad::giveTransformationJacobian(), oofem::FEI2dQuadLinAxi::giveTransformationJacobian(), oofem::FEI2dQuadQuadAxi::giveTransformationJacobian(), oofem::FEI2dTrConst::giveTransformationJacobian(), oofem::FEI2dTrLin::giveTransformationJacobian(), oofem::FEI2dTrLinAxi::giveTransformationJacobian(), oofem::FEI3dTetLin::giveTransformationJacobian(), oofem::MixedGradientPressureDirichlet::giveUnknown(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::Dof::giveUnknowns(), oofem::Dof::giveUnknowns(), oofem::Shell7Base::giveUnknownsAt(), oofem::DofManager::giveUnknownVector(), oofem::DofManager::giveUnknownVector(), oofem::LatticeDirichletCouplingNode::giveUnknownVector(), oofem::DofManager::giveUnknownVectorOfType(), oofem::CompoDamageMat::giveUnrotated3dMaterialStiffnessMatrix(), oofem::LEPlic::giveUpdatedCoordinate(), oofem::Node::giveUpdatedCoordinate(), oofem::Node::giveUpdatedCoordinates(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::FEI3dTetQuad::giveVolume(), oofem::LatticeBeam3dBoundary::giveVTKCoordinates(), oofem::Steel1::GiveYCStressGradient(), oofem::Shell7Base::giveZ2integratedPolynomial2GradientForStressRecAt(), oofem::Shell7Base::giveZintegratedPolynomialGradientForStressRecAt(), oofem::FEI1dHermite::global2local(), oofem::FEI1dLin::global2local(), oofem::FEI1dQuad::global2local(), oofem::FEI2dLineConst::global2local(), oofem::FEI2dLineHermite::global2local(), oofem::FEI2dLineLin::global2local(), oofem::FEI2dLineQuad::global2local(), oofem::FEI2dQuadLin::global2local(), oofem::FEI2dTrConst::global2local(), oofem::FEI2dTrLin::global2local(), oofem::FEI3dHexaConst::global2local(), oofem::FEI3dHexaLin::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::FEI3dLineLin::global2local(), oofem::FEI3dTetLin::global2local(), oofem::FEI3dTrQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::LSpace::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::LTRSpace::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::PlaneStress2d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::Quad1PlaneStrain::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::TrPlaneStrain::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::TrPlaneStress2d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::Truss1d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::DynCompRow::ILUPYourself(), oofem::FiberedCrossSection::imposeStrainConstrainsOnGradient(), oofem::LayeredCrossSection::imposeStrainConstrainsOnGradient(), oofem::StructuralCrossSection::imposeStrainConstrainsOnGradient(), oofem::FiberedCrossSection::imposeStressConstrainsOnGradient(), oofem::LayeredCrossSection::imposeStressConstrainsOnGradient(), oofem::StructuralCrossSection::imposeStressConstrainsOnGradient(), oofem::ConcreteDPM2::initDamaged(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::MazarsMaterial::initDamaged(), oofem::CompCol_ILUPreconditioner::initialize(), oofem::FCMMaterial::initializeCrack(), oofem::MDM::initializeData(), oofem::MicroplaneMaterial::initializeData(), oofem::GeneralSlaveNode::initializeFinish(), oofem::IGAElement::initializeFinish(), oofem::IGATSplineElement::initializeFinish(), oofem::AnisotropicLinearElasticMaterial::initializeFrom(), oofem::Element::initializeFrom(), oofem::LevelSetPCS::initializeFrom(), oofem::Node::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::PolygonLine::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::VTKXMLLatticeExportModule::initRegionNodeNumbering(), oofem::VTKXMLPeriodicExportModule::initRegionNodeNumbering(), oofem::OctreeSpatialLocalizer::insertElementIntoOctree(), oofem::FEI2dQuadConst::inside(), oofem::FEI2dQuadLin::inside(), oofem::FEI2dQuadQuad::inside(), oofem::FEI2dTrLin::inside(), oofem::FEI2dTrQuad::inside(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::TransverseReinfConstraint::integrateTangentOnConcrete(), oofem::TransverseReinfConstraint::integrateTangentOnSteel(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), oofem::HybridEI::interpGradLevelSet(), oofem::HybridEI::interpLevelSet(), oofem::HybridEI::interpLevelSetTangential(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::Quasicontinuum::intersectionTestSegmentSegment2D(), oofem::Quasicontinuum::intersectionTestSegmentTrianglePlucker3D(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::PolylineNonlocalBarrier::isActivated(), oofem::FRCFCMNL::isInElementProjection(), oofem::QCFullsolveddomain::isNodeInside(), oofem::Line::isPointInside(), oofem::FRCFCMNL::isStrengthExceeded(), oofem::FloatMatrix::jaco_(), oofem::Skyline::ldl_feti_sky(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::FEI1dHermite::local2global(), oofem::FEI1dLin::local2global(), oofem::FEI1dQuad::local2global(), oofem::FEI2dLineConst::local2global(), oofem::FEI2dLineHermite::local2global(), oofem::FEI2dLineLin::local2global(), oofem::FEI2dLineQuad::local2global(), oofem::FEI2dQuadConst::local2global(), oofem::FEI2dQuadLin::local2global(), oofem::FEI2dQuadQuad::local2global(), oofem::FEI2dTrConst::local2global(), oofem::FEI2dTrLin::local2global(), oofem::FEI2dTrQuad::local2global(), oofem::FEI3dHexaConst::local2global(), oofem::FEI3dHexaLin::local2global(), oofem::FEI3dHexaQuad::local2global(), oofem::FEI3dLineLin::local2global(), oofem::FEI3dQuadLin::local2global(), oofem::FEI3dTetLin::local2global(), oofem::FEI3dTrLin::local2global(), oofem::FEI3dTrQuad::local2global(), oofem::FEI3dWedgeLin::local2global(), oofem::FEI3dWedgeQuad::local2global(), oofem::Quad10_2D_SUPG::LS_PCS_computeF(), oofem::TR1_2D_SUPG::LS_PCS_computeF(), oofem::Tet1_3D_SUPG::LS_PCS_computeS(), oofem::TR1_2D_SUPG::LS_PCS_computeS(), oofem::Tet1_3D_SUPG::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG_AXI::LS_PCS_computeVOFFractions(), oofem::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::VTKBaseExportModule::makeFullTensorForm(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LayeredCrossSection::mapLayerGpCoordsToShellCoords(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::Shell7BaseXFEM::mapXi3FromLocalToShell(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::MDM::MMI_map(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunction_1D_Around(), oofem::MisesMatNl::modifyNonlocalWeightFunctionAround(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::Hexa21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::IntElLine1::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalAveragingRecoveryMI_computeNodalValue(), oofem::tet21ghostsolid::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tet21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tr21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_recoverValues(), oofem::QClinearStatic::nodeInFullSolvedDomainTest(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha2(), oofem::AnisotropicDamageMaterial::obtainAlpha3(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputGradient(), oofem::GnuplotExportModule::outputReactionForces(), oofem::GnuplotExportModule::outputXFEM(), oofem::EngngModel::packDofManagers(), oofem::NodalAveragingRecoveryModel::packSharedDofManData(), oofem::SPRNodalRecoveryModel::packSharedDofManData(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::LevelSetPCS::pcs_stage1(), oofem::MisesMat::performPlasticityReturn(), oofem::RankineMat::performPlasticityReturn(), oofem::TrabBoneMaterial::performPlasticityReturn(), oofem::MisesMat::performPlasticityReturn_PlaneStress(), oofem::ConcreteDPM2::performRegularReturn(), oofem::FloatMatrix::plus_Nt_a_otimes_b_B(), oofem::FloatMatrix::plusDyadSymmUpper(), oofem::FloatMatrix::plusDyadUnsym(), plusProduct(), oofem::AnisotropicDamageMaterialStatus::printOutputAt(), oofem::LatticeStructuralElement::printOutputAt(), oofem::LineDistributedSpring::printOutputAt(), oofem::NodalSpringElement::printOutputAt(), oofem::RerShell::printOutputAt(), oofem::TR_SHELL01::printOutputAt(), oofem::TransientTransportProblem::printOutputAt(), oofem::StructuralEngngModel::printReactionForces(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::Skyline::rbmodes(), oofem::PrimaryField::readDofManager(), oofem::Lattice2dBoundary::recalculateCoordinates(), oofem::Lattice3dBoundary::recalculateCoordinates(), oofem::Lattice3dBoundaryTruss::recalculateCoordinates(), oofem::LatticeLink3dBoundary::recalculateCoordinates(), oofem::LIBeam3dBoundary::recalculateCoordinates(), oofem::LTRSpaceBoundary::recalculateCoordinates(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::LevelSetPCS::redistance(), oofem::PetscSparseMtrx::scatterG2L(), oofem::CylindricalALM::search(), oofem::PrescribedDispSlipHomogenization::setDispField(), oofem::PrescribedDispSlipHomogenization::setDispGradient(), oofem::ConcreteDPMStatus::setIPValue(), oofem::DustMaterial::setIPValue(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::BoundingBox::setOrigin(), oofem::MixedGradientPressureNeumann::setPrescribedDeviatoricGradientFromVoigt(), oofem::PrescribedGenStrainShell7::setPrescribedGenStrainShell7Voigt(), oofem::PrescribedGradientHomogenization::setPrescribedGradientVoigt(), oofem::PrescribedDispSlipHomogenization::setSlipField(), oofem::PrescribedDispSlipHomogenization::setSlipGradient(), oofem::FCMMaterialStatus::setTempNormalCrackStrainVector(), oofem::Shell7Base::setupInitialEdgeSolutionVector(), oofem::GaussIntegrationRule::SetUpPointsOn2DEmbeddedLine(), oofem::GaussIntegrationRule::SetUpPointsOn3dDegShell(), oofem::GaussIntegrationRule::SetUpPointsOn3dDegShellLayers(), oofem::GaussIntegrationRule::SetUpPointsOnCube(), oofem::LobattoIntegrationRule::SetUpPointsOnCube(), oofem::GaussIntegrationRule::SetUpPointsOnCubeLayers(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), oofem::GaussIntegrationRule::SetUpPointsOnLine(), oofem::LobattoIntegrationRule::SetUpPointsOnLine(), oofem::GaussIntegrationRule::SetUpPointsOnSquare(), oofem::LobattoIntegrationRule::SetUpPointsOnSquare(), oofem::GaussIntegrationRule::SetUpPointsOnTetrahedra(), oofem::GaussIntegrationRule::SetUpPointsOnTriangle(), oofem::PatchIntegrationRule::SetUpPointsOnTriangle(), oofem::GaussIntegrationRule::SetUpPointsOnWedge(), oofem::LayeredIntegrationRule::SetUpPointsOnWedge(), oofem::PatchIntegrationRule::SetUpPointsOnWedge(), oofem::GaussIntegrationRule::SetUpPointsOnWedgeLayers(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::VTKXMLLatticeExportModule::setupVTKPiece(), oofem::VTKXMLPeriodicExportModule::setupVTKPiece(), oofem::VTKXMLLatticeExportModule::setupVTKPieceCross(), oofem::Parser::setVariableValue(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::FreemInterface::smoothNodalDensities(), oofem::CylindricalALM::solve(), oofem::GJacobi::solve(), oofem::InverseIteration::solve(), oofem::NRSolver::solve(), oofem::SLEPcSolver::solve(), oofem::SpoolesSolver::solve(), oofem::StaggeredSolver::solve(), oofem::SubspaceIteration::solve(), oofem::FloatMatrix::solveForRhs(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::CBS::solveYourselfAt(), oofem::DEIDynamic::solveYourselfAt(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::StructuralMaterial::sortPrincDirAndValCloseTo(), oofem::SpatialLocalizerInterface::SpatialLocalizerI_BBoxContainsPoint(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::PrimaryField::storeDofManager(), oofem::CemhydMat::storeWeightTemperatureProductVolume(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEI3dTetLin::surfaceEvaldNdx(), oofem::FEI3dTetQuad::surfaceEvaldNdx(), oofem::FEI3dHexaLin::surfaceEvaldNdxi(), oofem::FEI3dTrLin::surfaceEvaldNdxi(), oofem::FEI3dTrQuad::surfaceEvaldNdxi(), oofem::FEI3dHexaLin::surfaceEvalN(), oofem::FEI3dHexaQuad::surfaceEvalN(), oofem::FEI3dHexaTriQuad::surfaceEvalN(), oofem::FEI3dQuadLin::surfaceEvalN(), oofem::FEI3dTetLin::surfaceEvalN(), oofem::FEI3dTetQuad::surfaceEvalN(), oofem::FEI3dTrLin::surfaceEvalN(), oofem::FEI3dTrQuad::surfaceEvalN(), oofem::FEI3dWedgeLin::surfaceEvalN(), oofem::FEI3dWedgeQuad::surfaceEvalN(), oofem::FEI3dHexaLin::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceEvalNormal(), oofem::FEI3dHexaTriQuad::surfaceEvalNormal(), oofem::FEI3dTetQuad::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dQuadLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrQuad::surfaceGiveJacobianMatrixAt(), oofem::FEI3dHexaLin::surfaceLocal2global(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::FEI3dTetLin::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::OctantRec::testBoundingBox(), oofem::OctantRecT< T > *::testBoundingSphere(), oofem::Skyline::times(), oofem::SkylineUnsym::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::SkylineUnsym::timesT(), oofem::Tr_Warp::transformCoordinates(), oofem::Line::transformIntoPolar(), oofem::MDM::transformStrainToPDC(), oofem::MDM::transformStressFromPDC(), oofem::EngngModel::unpackDofManagers(), oofem::NodalAveragingRecoveryModel::unpackSharedDofManData(), oofem::SPRNodalRecoveryModel::unpackSharedDofManData(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::Subdivision::unpackSharedIrregulars(), oofem::PrescribedDispSlipBCDirichletRC::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::FreeWarping::updateComputedResults(), oofem::FCMMaterial::updateCrackStatus(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::NLTransientTransportProblem::updateDofUnknownsDictionary(), oofem::PFEM::updateDofUnknownsDictionary(), oofem::PFEM::updateDofUnknownsDictionaryPressure(), oofem::PFEM::updateDofUnknownsDictionaryVelocities(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::Shell7Base::updateLayerTransvNormalStressSR(), oofem::Shell7Base::updateLayerTransvShearStressesSR(), oofem::Shell7Base::updateLayerTransvStressesSR(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::LevelSetPCS::updatePosition(), oofem::NodalRecoveryModel::updateRegionRecoveredValues(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::SUPG::updateSolutionVectors(), oofem::SUPG::updateSolutionVectors_predictor(), oofem::Tet1_3D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG_AXI::updateStabilizationCoeffs(), oofem::LIBeam3dNL2::updateTempQuaternion(), oofem::LIBeam3d2::updateTempTriad(), oofem::LIBeam3dNL::updateTempTriad(), oofem::FastMarchingMethod::updateTrialValue(), oofem::SolutionbasedShapeFunction::whichBoundary(), oofem::VTKXMLExportModule::writeCellVars(), oofem::VTKXMLLatticeExportModule::writeCellVarsCross(), oofem::ErrorCheckingExportModule::writeCheck(), oofem::VTKXMLExportModule::writeExternalForces(), oofem::VTKXMLExportModule::writeIntVars(), oofem::VTKXMLExportModule::writePrimaryVars(), oofem::VTKXMLExportModule::writeVTKCellData(), oofem::VTKXMLLatticeExportModule::writeVTKPieceCross(), oofem::VTKXMLExportModule::writeVTKPieceProlog(), oofem::VTKXMLExportModule::writeVTKPointData(), oofem::VTKXMLXFemExportModule::writeXFEMVars(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeDeformationGradientVector(), oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt(), oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule(), oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions(), oofem::TR_SHELL01::ZZErrorEstimatorI_computeLocalStress(), oofem::TR_SHELL02::ZZErrorEstimatorI_computeLocalStress(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().

◆ at() [2/2]

double oofem::FloatArray::at ( Index i) const
inline

Coefficient access function. Returns l-value of coefficient at given position of the receiver. Provides 1-based indexing access.

Parameters
iPosition of coefficient in array.

Definition at line 214 of file floatarray.h.

References checkBounds().

◆ beColumnOf()

void oofem::FloatArray::beColumnOf ( const FloatMatrix & mat,
int col )

Reciever will be set to a given column in a matrix

Todo
This duplicates the "copyColumn" from FloatMatrix.

Definition at line 1182 of file floatarray.C.

References oofem::FloatMatrix::copyColumn(), and FloatMatrix.

Referenced by oofem::Tr2Shell7::computeAreaAround(), oofem::SolidShell::computeBondTransformationMatrix(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Shell7Base::computePressureForceAt(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::Shell7Base::CopyIPvaluesToNodes(), oofem::VTKBaseExportModule::getCellVariableFromIS(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), 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::giveLayerContributionToSR(), oofem::Structural2DElement::giveMaterialOrientationAt(), oofem::Structural3DElement::giveMaterialOrientationAt(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::NCPrincipalStrain::nucleateEnrichmentItems(), oofem::NCPrincipalStress::nucleateEnrichmentItems(), oofem::PLPrincipalStrain::propagateInterface(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), oofem::Shell7Base::setupInitialNodeDirectors(), and oofem::SubspaceIteration::solve().

◆ beDifferenceOf() [1/2]

void oofem::FloatArray::beDifferenceOf ( const FloatArray & a,
const FloatArray & b )

Sets receiver to be a - b.

Parameters
aArray which receiver goes to.
bArray which receiver comes from.

Definition at line 403 of file floatarray.C.

References _resize_internal(), FloatArray(), giveSize(), OOFEM_ERROR, resize(), and size().

Referenced by oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::HOMExportModule::average(), oofem::SolidShell::computeAlpha(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::TR_SHELL11::computeGtoLRotationMatrix(), oofem::TrPlanestressRotAllman3d::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::BasicGeometry::computeLineDistance(), oofem::RigidArmNode::computeMasterContribution(), oofem::CCTPlate::computeMidPlaneNormal(), oofem::DKTPlate::computeMidPlaneNormal(), oofem::QDKTPlate::computeMidPlaneNormal(), oofem::Quad1PlateSubSoil::computeMidPlaneNormal(), oofem::Tria1PlateSubSoil::computeMidPlaneNormal(), oofem::PolygonLine::computeNormalSignDist(), oofem::Line::computeProjection(), oofem::Line::computeTangentialDistanceToEnd(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::IsotropicDamageMaterialStatus::computeWork(), oofem::RankineMatStatus::computeWork_1d(), oofem::RankineMatStatus::computeWork_PlaneStress(), oofem::FEI3dLineLin::evaldNdx(), oofem::PrescribedGradientBCPeriodic::findSlaveToMasterMap(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::PrescribedDispSlipBCDirichletRC::give(), oofem::PrescribedGenStrainShell7::give(), oofem::PrescribedGradient::give(), oofem::RotatingBoundary::give(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::CCTPlate3d::giveLocalCoordinates(), oofem::DKTPlate3d::giveLocalCoordinates(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FCMMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::LinearElasticMaterial::giveRealStressVector_2dBeamLayer(), oofem::LinearElasticMaterial::giveRealStressVector_PlateLayer(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::PolygonLine::giveTips(), oofem::PrescribedGradientBCWeak::giveTractionElNormal(), oofem::MixedGradientPressureDirichlet::giveUnknown(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::FEI3dHexaQuad::global2local(), oofem::FEI3dLineLin::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::operator-(), oofem::Triangle::pointIsInTriangle(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::DynamicRelaxationSolver::solve(), oofem::NRSolver::solve(), oofem::StaggeredSolver::solve(), oofem::SUPG::solveYourselfAt(), oofem::FEI3dTetLin::surfaceEvalNormal(), oofem::Line::transformIntoPolar(), oofem::TransientTransportProblem::updateComponent(), oofem::TransientTransportProblem::updateInternalRHS(), oofem::FastMarchingMethod::updateTrialValue(), and oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule().

◆ beDifferenceOf() [2/2]

void oofem::FloatArray::beDifferenceOf ( const FloatArray & a,
const FloatArray & b,
Index n )

Sets receiver to be a - b, using only the first n entries.

Parameters
aArray which receiver goes to.
bArray which receiver comes from.
nOnly first n entries are taken.

Definition at line 425 of file floatarray.C.

References _resize_internal(), FloatArray(), giveSize(), OOFEM_ERROR, and size().

◆ begin() [1/2]

◆ begin() [2/2]

std::vector< double >::const_iterator oofem::FloatArray::begin ( ) const
inline

Definition at line 109 of file floatarray.h.

◆ beMaxOf()

void oofem::FloatArray::beMaxOf ( const FloatArray & a,
const FloatArray & b )

◆ beMinOf()

void oofem::FloatArray::beMinOf ( const FloatArray & a,
const FloatArray & b )

◆ beProductOf()

void oofem::FloatArray::beProductOf ( const FloatMatrix & aMatrix,
const FloatArray & anArray )

Receiver becomes the result of the product of aMatrix and anArray. Adjusts the size of receiver if necessary.

Definition at line 689 of file floatarray.C.

References _resize_internal(), at(), oofem::FloatMatrix::at(), FloatArray(), FloatMatrix, oofem::FloatMatrix::giveNumberOfColumns(), oofem::FloatMatrix::giveNumberOfRows(), givePointer(), oofem::FloatMatrix::givePointer(), giveSize(), OOFEM_ERROR, and sum().

Referenced by oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DGProblem::assembleDirichletBcRhsVector(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::ContactBoundaryCondition::assembleExtrapolatedForces(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::TransverseReinfConstraint::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorStress(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::SUPGElement2::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::SUPGElement2::computeAdvectionTerm_MC(), oofem::SolidShell::computeAlpha(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::PhaseFieldElement::computeBStress_u(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::Shell7Base::computeCauchyStressVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::Lattice3d::computeCrossSectionProperties(), oofem::Lattice3d_mt::computeCrossSectionProperties(), oofem::RCSDEMaterial::computeCurrEquivStrain(), oofem::RCSDMaterial::computeCurrEquivStrain(), oofem::MazarsMaterial::computeDamageParam(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::GradDpElement::computeDeformationGradientVector(), oofem::GradientDamageElement::computeDeformationGradientVector(), oofem::LTRSpaceBoundary::computeDeformationGradientVector(), oofem::NLStructuralElement::computeDeformationGradientVector(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::tet21ghostsolid::computeDeformationGradientVectorFromDispl(), oofem::Truss3dnl2::computeDeformedLength(), oofem::SUPGElement2::computeDeviatoricStrain(), oofem::TR1_2D_SUPG_AXI::computeDeviatoricStrain(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::Shell7BaseXFEM::computeDiscGeneralizedStrainVector(), oofem::MDM::computeEffectiveStress(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::RankineMat::computeEta(), oofem::TransportGradientNeumann::computeEta(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGradientBCWeak::computeField(), oofem::QTrPlaneStress2dXFEM::computeField(), oofem::StructuralElement::computeField(), oofem::TransportElement::computeField(), oofem::TrPlaneStress2dXFEM::computeField(), oofem::TransportElement::computeFlow(), oofem::SolidShell::computeFVector(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::TransportElement::computeInertiaForcesVector(), oofem::Truss3dnl::computeInitialStressStiffness(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::TransportElement::computeInternalForcesVector(), oofem::PolygonLine::computeIntersectionPoints(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::Truss3dnl2::computeLength(), oofem::BasicGeometry::computeLineDistance(), oofem::tet21ghostsolid::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::GradDpElement::computeLocalStrainVector(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::GradientDamageElement::computeNonlocalDamageDrivingVariableGradient(), oofem::GradDpElement::computeNonlocalGradient(), oofem::AnisotropicDamageMaterial::computePlaneStressSigmaZ(), oofem::AnisotropicDamageMaterial::computePlaneStressStrain(), oofem::PerfectlyPlasticMaterial::computePlasticStiffnessAt(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::CBSElement::computePrescribedTermsI(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::Shell7Base::computeSectionalForces(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::BaseMixedPressureElement::computeStrainVector(), oofem::GradientDamageElement::computeStrainVector(), oofem::Lattice2dBoundary::computeStrainVector(), oofem::Lattice3dBoundary::computeStrainVector(), oofem::Lattice3dBoundaryTruss::computeStrainVector(), oofem::LatticeLink3dBoundary::computeStrainVector(), oofem::LIBeam3d2::computeStrainVector(), oofem::LIBeam3dBoundary::computeStrainVector(), oofem::LTRSpaceBoundary::computeStrainVector(), oofem::Quad1MindlinShell3D::computeStrainVector(), oofem::StructuralElement::computeStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::TMBTSigTerm::computeTMgeneralizedStrain(), oofem::J2plasticMaterial::computeTrialStressIncrement(), oofem::MPlasticMaterial2::computeTrialStressIncrement(), oofem::MPlasticMaterial::computeTrialStressIncrement(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::GravityPressure::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::CrackExportModule::doOutput(), oofem::StructuralElementEvaluator::drawIGAPatchDeformedGeometry, oofem::Shell7Base::edgeEvalCovarBaseVectorsAt(), oofem::Shell7BaseXFEM::edgeEvalEnrCovarBaseVectorsAt(), oofem::BTamNTerm::evaluate(), oofem::BTSigmaTerm2::evaluate(), oofem::BTSigTerm::evaluate(), oofem::deltaBTfiNpTerm::evaluate(), oofem::deltaBTNpTerm::evaluate(), oofem::dnTaN::evaluate(), oofem::gNTfTerm::evaluate(), oofem::NdTdvfNpTerm::evaluate(), oofem::NTamTBTerm::evaluate(), oofem::NTBdivTerm::evaluate(), oofem::NTcN::evaluate(), oofem::NTN::evaluate(), oofem::TMgNTfTerm::evaluate(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncDerivAt(), oofem::PrescribedDispSlipBCDirichletRC::give(), oofem::PrescribedGenStrainShell7::give(), oofem::PrescribedGradient::give(), oofem::RotatingBoundary::give(), oofem::IsotropicLinearElasticMaterial::giveCharacteristicVector(), oofem::PFEMElement::giveCharacteristicVector(), oofem::SUPGElement2::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::TMSimpleMaterial::giveCharacteristicVector(), oofem::UPSimpleMaterial::giveCharacteristicVector(), oofem::Beam3d::giveCompositeExportData(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::Shell7BaseXFEM::giveDisUnknownsAt(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::MPSMaterial::giveEigenStrainVector(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::Element::giveGlobalIPValue(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_BB(), oofem::RankineMatGrad::giveGradientDamageStiffnessMatrix_du_NB(), oofem::Beam3d::giveInternalForcesVector(), oofem::BondLink3d::giveInternalForcesVector(), oofem::BondLink3dBoundary::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::Lattice2dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeBeam3d::giveInternalForcesVector(), oofem::LatticeBeam3dBoundary::giveInternalForcesVector(), oofem::LatticeLink3d::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::LIBeam3dBoundary::giveInternalForcesVector(), oofem::LIBeam3dNL2::giveInternalForcesVector(), oofem::LIBeam3dNL::giveInternalForcesVector(), oofem::LineDistributedSpring::giveInternalForcesVector(), oofem::LTRSpaceBoundary::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::QPlaneStress2dSlip::giveInternalForcesVector(), oofem::QTrPlaneStress2dSlip::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::SolidShell::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector_d(), oofem::PhaseFieldElement::giveInternalForcesVector_d(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_u(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::FCMMaterial::giveIPValue(), oofem::LIBeam3dBoundary::giveIPValue(), oofem::LTRSpaceBoundary::giveIPValue(), oofem::QPlaneStress2dSlip::giveIPValue(), oofem::QTrPlaneStress2dSlip::giveIPValue(), oofem::StructuralElement::giveIPValue(), oofem::tet21ghostsolid::giveIPValue(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::CCTPlate3d::giveLocalCoordinates(), oofem::DKTPlate3d::giveLocalCoordinates(), oofem::RerShell::giveLocalCoordinates(), oofem::TR_SHELL11::giveLocalCoordinates(), oofem::TrPlaneStrRot3d::giveLocalCoordinates(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::GradDpElement::giveNonlocalInternalForcesVector(), oofem::MisesMat::givePlaneStressStiffMtrx(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::ConcreteFCMViscoElastic::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::LinearElasticMaterial::giveRealStressVector_1d(), oofem::LinearElasticMaterial::giveRealStressVector_2dBeamLayer(), oofem::LinearElasticMaterial::giveRealStressVector_Fiber(), oofem::LinearElasticMaterial::giveRealStressVector_PlaneStress(), oofem::LinearElasticMaterial::giveRealStressVector_PlateLayer(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::IsotropicGradientDamageMaterial::giveRealStressVectorGradientDamage(), oofem::IsotropicLinearElasticMaterial::giveRealStressVectorUP_3d(), oofem::IsotropicLinearElasticMaterial::giveRealStressVectorUP_PlaneStrain(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::Shell7Base::giveUnknownsAt(), oofem::DofManager::giveUnknownVectorOfType(), oofem::Homogenize::herveZaoui(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionDev(), oofem::Tet1_3D_SUPG::LS_PCS_computeF(), oofem::TR21_2D_SUPG::LS_PCS_computeF(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::operator*(), oofem::MisesMat::performPlasticityReturn_PlaneStress(), oofem::FETISolver::projection(), oofem::PLHoopStressCirc::propagateInterface(), oofem::Shell7BaseXFEM::recoverShearStress(), rotatedWith(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::FETISolver::solve(), oofem::SubspaceIteration::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::Line::transformIntoPolar(), oofem::StressStrainBaseVector::transformTo(), oofem::Lattice2d_mt::updateInternalState(), oofem::Lattice3d_mt::updateInternalState(), oofem::TransportElement::updateInternalState(), oofem::Tet1_3D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::LinearizedDilationForceAssembler::vectorFromElement(), oofem::MatrixProductAssembler::vectorFromElement(), oofem::PFEMCorrectionRhsAssembler::vectorFromElement(), oofem::PFEMLaplaceVelocityAssembler::vectorFromElement(), oofem::PFEMMassVelocityAssembler::vectorFromElement(), oofem::PFEMPressureRhsAssembler::vectorFromElement(), oofem::ScalarAdvectionRhsAssembler::vectorFromElement(), oofem::SUPGInternalForceAssembler::vectorFromElement(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeDeformationGradientVector(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

◆ beRowOf()

void oofem::FloatArray::beRowOf ( const FloatMatrix & mat,
Index row )

Reciever will be set to a given row in a matrix

Definition at line 1188 of file floatarray.C.

References _resize_internal(), at(), oofem::FloatMatrix::at(), oofem::FloatMatrix::cols(), FloatMatrix, OOFEM_ERROR, and oofem::FloatMatrix::rows().

Referenced by oofem::Element::giveLocalCoordinateSystemVector().

◆ beScaled()

void oofem::FloatArray::beScaled ( double s,
const FloatArray & b )

Sets receiver to be \( a = s b \).

Parameters
sScaling factor.
bVector to be scaled.

Definition at line 208 of file floatarray.C.

References _resize_internal(), FloatArray(), and size().

Referenced by add(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorStress(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::ConstantEdgeLoad::computeValueAt(), oofem::ConstantSurfaceLoad::computeValueAt(), oofem::FreeConstantSurfaceLoad::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::MPSDamMaterialStatus::giveCrackVector(), oofem::PolygonLine::giveGlobalCoordinates(), oofem::RankineMat::giveRealStressVector_1d(), oofem::RankineMat::giveRealStressVector_PlaneStress(), oofem::MisesMatGrad::giveRealStressVectorGradientDamage(), oofem::RankineMatGrad::giveRealStressVectorGradientDamage(), oofem::PolygonLine::giveSubPolygon(), oofem::PrescribedGradientBCWeak::giveTractionElArcPos(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), oofem::FEI3dLineLin::local2global(), oofem::operator*(), oofem::operator*(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), and oofem::Triangle::refineTriangle().

◆ beSubArrayOf()

void oofem::FloatArray::beSubArrayOf ( const FloatArray & src,
const IntArray & indx )

Extract sub vector form src array and stores the result into receiver.

Parameters
srcsource vector for sub vector
indxDetermines sub vector. Receiver size will be indx max value, and on i-th position of subVector will be src(indx->at(i)) value.

Definition at line 440 of file floatarray.C.

References _resize_internal(), at(), oofem::IntArray::at(), FloatArray(), giveSize(), oofem::IntArray::maximum(), oofem::IntArray::minimum(), OOFEM_ERROR, and oofem::IntArray::size().

Referenced by oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::Quad1MindlinShell3D::computeVectorOfUnknowns(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::QPlaneStress2dSlip::giveInternalForcesVector(), oofem::QTrPlaneStress2dSlip::giveInternalForcesVector(), oofem::Shell7BaseXFEM::giveInternalForcesVector(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::QPlaneStress2dSlip::giveIPValue(), oofem::QTrPlaneStress2dSlip::giveIPValue(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::StructuralMaterial::giveReducedSymVectorForm(), and oofem::StructuralMaterial::giveReducedVectorForm().

◆ beSymVectorForm()

void oofem::FloatArray::beSymVectorForm ( const FloatMatrix & aMatrix)

Reciever will be a vector with 6 components formed from a 3x3 matrix. Off-diagonals of the matrix are symmetrized. Order of matrix components in vector: 11, 22, 33, 23, 13, 12

Parameters
aMatrixMatrix to transform.

Definition at line 1102 of file floatarray.C.

References oofem::FloatMatrix::at(), FloatMatrix, oofem::FloatMatrix::giveNumberOfColumns(), oofem::FloatMatrix::giveNumberOfRows(), and OOFEM_ERROR.

Referenced by oofem::Shell7Base::computeCauchyStressVector(), and oofem::AnisotropicDamageMaterial::giveRealStressVector().

◆ beSymVectorFormOfStrain()

◆ beTProductOf()

void oofem::FloatArray::beTProductOf ( const FloatMatrix & aMatrix,
const FloatArray & anArray )

Receiver becomes the result of the product of aMatrix^T and anArray. Adjusts the size of receiver if necessary.

Definition at line 721 of file floatarray.C.

References _resize_internal(), at(), oofem::FloatMatrix::at(), FloatArray(), FloatMatrix, oofem::FloatMatrix::giveNumberOfColumns(), oofem::FloatMatrix::giveNumberOfRows(), givePointer(), oofem::FloatMatrix::givePointer(), giveSize(), OOFEM_ERROR, and sum().

Referenced by oofem::MixedGradientPressureNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::TransverseReinfConstraint::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorStress(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGenStrainShell7::computeField(), oofem::PrescribedGradient::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::StructuralPenaltyContactBoundaryCondition::computeInternalForcesFromContact(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::StructuralElement::computePointLoadVectorAt(), oofem::Shell7Base::computePressureForce(), oofem::HTSelement::computePsVectorAt(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::PrescribedDispSlipBCDirichletRC::computeStress(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::LIBeam3dNL::computeTempCurv(), oofem::TMBTSigTerm::computeTMgeneralizedStrain(), oofem::Shell7Base::computeTractionForce(), oofem::TransportGradientDirichlet::computeXi(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::BTmuBTerm::evaluate(), oofem::BTmuVfBTerm::evaluate(), oofem::BTSigmaTerm2::evaluate(), oofem::BTSigTerm::evaluate(), oofem::gNTfTerm::evaluate(), oofem::InternalTMFluxSourceTerm::evaluate(), oofem::NTf_Body::evaluate(), oofem::NTf_Edge::evaluate(), oofem::NTf_Surface::evaluate(), oofem::NTfTerm::evaluate(), oofem::NTmuVfSNTerm::evaluate(), oofem::TMBTSigTerm::evaluate(), oofem::TMgNTfTerm::evaluate(), oofem::NdTdvfNpTerm::evaluate_lin(), oofem::VTKExportModule::exportPrimVarAs(), oofem::Beam3d::giveCompositeExportData(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::GradientDamageElement::giveInternalForcesVector_d(), oofem::PhaseFieldElement::giveInternalForcesVector_d(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::BaseMixedPressureElement::giveInternalForcesVector_u(), oofem::GradientDamageElement::giveInternalForcesVector_u(), oofem::CoupledFieldsElement::giveInternalForcesVectorGen(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::Tet1_3D_SUPG::LS_PCS_computeF(), oofem::TR21_2D_SUPG::LS_PCS_computeF(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::LevelSetPCS::pcs_stage1(), oofem::FETISolver::projection(), rotatedWith(), oofem::FETISolver::solve(), oofem::TR_SHELL01::SpatialLocalizerI_giveBBox(), oofem::TR_SHELL02::SpatialLocalizerI_giveBBox(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

◆ beVectorForm()

void oofem::FloatArray::beVectorForm ( const FloatMatrix & aMatrix)

◆ beVectorProductOf()

void oofem::FloatArray::beVectorProductOf ( const FloatArray & v1,
const FloatArray & v2 )

Computes vector product (or cross product) of vectors given as parameters, \( v_1 \times v_2 \), and stores the result into receiver.

Parameters
v1First vector in the product.
v2Second vector in the product.

Definition at line 476 of file floatarray.C.

References _resize_internal(), at(), FloatArray(), giveSize(), and OOFEM_ERROR.

Referenced by oofem::FloatMatrix::beLocalCoordSys(), oofem::IntElSurfQuad1::computeAreaAround(), oofem::IntElSurfTr1::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::Lattice3d::computeCrossSectionProperties(), oofem::Lattice3d_mt::computeCrossSectionProperties(), oofem::LatticeBeam3d::computeCrossSectionProperties(), oofem::TMElement::computeFluxLBToLRotationMatrix(), oofem::UPElement::computeFluxLBToLRotationMatrix(), oofem::BondLink3d::computeGeometryProperties(), oofem::BondLink3dBoundary::computeGeometryProperties(), oofem::LatticeLink3d::computeGeometryProperties(), oofem::LatticeLink3dBoundary::computeGeometryProperties(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::TR_SHELL11::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::CCTPlate::computeMidPlaneNormal(), oofem::DKTPlate::computeMidPlaneNormal(), oofem::QDKTPlate::computeMidPlaneNormal(), oofem::Quad1PlateSubSoil::computeMidPlaneNormal(), oofem::Tria1PlateSubSoil::computeMidPlaneNormal(), oofem::Shell7Base::computePressureForceAt(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::IntElSurfQuad1::computeTransformationMatrixAt(), oofem::IntElSurfTr1::computeTransformationMatrixAt(), oofem::GravityPressure::computeValueAt(), oofem::LSpace::drawTriad(), oofem::CohesiveSurface3d::evaluateLocalCoordinateSystem(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::FEI3dTrLin::giveArea(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::Structural3DElement::giveMaterialOrientationAt(), oofem::MicroplaneMaterial::initializeData(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::Triangle::pointIsInTriangle(), oofem::FEI3dHexaLin::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceEvalNormal(), oofem::FEI3dHexaTriQuad::surfaceEvalNormal(), oofem::FEI3dQuadLin::surfaceEvalNormal(), oofem::FEI3dTetLin::surfaceEvalNormal(), oofem::FEI3dTetQuad::surfaceEvalNormal(), oofem::FEI3dTrLin::surfaceEvalNormal(), oofem::FEI3dTrQuad::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dQuadLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrLin::surfaceGiveJacobianMatrixAt(), and oofem::FEI3dTrQuad::surfaceGiveJacobianMatrixAt().

◆ changeComponentOrder()

void oofem::FloatArray::changeComponentOrder ( )

Swaps the fourth and sixth index in the array. This is to reorder the indices from OOFEM's order to Abaqus' and vice versa.

Definition at line 1122 of file floatarray.C.

References at(), FloatArray(), and giveSize().

◆ checkBounds()

void oofem::FloatArray::checkBounds ( Index i) const
inline

Checks size of receiver towards requested bounds. Current implementation will call exit(1), if dimension mismatch found.

Parameters
iRequired size of receiver.

Definition at line 228 of file floatarray.h.

References OOFEM_ERROR, and size().

Referenced by at(), at(), operator[](), and operator[]().

◆ checkSizeTowards()

void oofem::FloatArray::checkSizeTowards ( const IntArray & loc)

Checks size of receiver towards values stored in loc array. Expands the receiver if loc points to coefficients beyond the size of receiver.

Parameters
locArray with indices.

Definition at line 658 of file floatarray.C.

References giveSize(), oofem::IntArray::maximum(), and resize().

◆ clear()

void oofem::FloatArray::clear ( )
inline

Clears receiver (zero size). Same effect as resizing to zero, but has a clearer meaning and intent when used.

Definition at line 254 of file floatarray.h.

Referenced by oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::EngngModel::assembleVectorFromElements(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::DummyFEInterpolation::boundaryEdgeEvalN(), oofem::DummyFEInterpolation::boundaryEdgeEvalNormal(), oofem::DummyFEInterpolation::boundaryEdgeLocal2Global(), oofem::DummyFEInterpolation::boundaryEvalN(), oofem::DummyFEInterpolation::boundaryEvalNormal(), oofem::DummyFEInterpolation::boundaryLocal2Global(), oofem::DummyFEInterpolation::boundarySurfaceEvalN(), oofem::DummyFEInterpolation::boundarySurfaceEvalNormal(), oofem::DummyFEInterpolation::boundarySurfaceLocal2global(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::SUPGElement2::computeAdvectionTerm_MB(), oofem::SUPGElement2::computeAdvectionTerm_MC(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TR_SHELL11::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::Element::computeBoundaryEdgeLoadVector(), oofem::Shell7Base::computeBoundaryEdgeLoadVector(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::Element::computeBoundarySurfaceLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::SUPGElement2::computeDiffusionTerm_MB(), oofem::SUPGElement2::computeDiffusionTerm_MC(), oofem::Hexa21Stokes::computeExternalForcesVector(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::Tet21Stokes::computeExternalForcesVector(), oofem::Tr21Stokes::computeExternalForcesVector(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGradientMultiple::computeField(), oofem::Element::computeGlobalCoordinates(), oofem::LTRSpaceBoundary::computeGlobalCoordinates(), oofem::Shell7Base::computeGlobalCoordinates(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::StructuralPenaltyContactBoundaryCondition::computeInternalForcesFromContact(), oofem::TransportElement::computeInternalForcesVector(), oofem::TransportElement::computeInternalSourceRhsSubVectorAt(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::TransportMaterial::computeInternalSourceVector(), oofem::VTKBaseExportModule::computeIPAverage(), oofem::XfemStructuralElementInterface::computeIPAverageInTriangle(), oofem::J2Mat::computeKGradientVector(), oofem::DofManager::computeLoadVector(), oofem::Element::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Node::computeLoadVector(), oofem::PFEMElement::computeLoadVector(), oofem::StructuralElement::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::TR1_2D_SUPG::computeLoadVector(), oofem::TR1_2D_SUPG_AXI::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::TransportElement::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::ConstantEdgeLoad::computeNArray(), oofem::ConstantPressureLoad::computeNArray(), oofem::ConstantSurfaceLoad::computeNArray(), oofem::FreeConstantSurfaceLoad::computeNArray(), oofem::NeumannMomentLoad::computeNArray(), oofem::UsrDefBoundaryLoad::computeNArray(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::PrescribedDispSlipMultiple::computeReinfStress(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::Shell7Base::computeSectionalForcesAt(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::PrescribedDispSlipMultiple::computeStress(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::RankinePlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::RankinePlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::LumpedMassElement::computeStressVector(), oofem::NodalSpringElement::computeStressVector(), oofem::SpringElement::computeStressVector(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::PrescribedDispSlipMultiple::computeTransferStress(), oofem::CylindricalALM::do_lineSearch(), oofem::Node::drawYourself(), oofem::FEI3dHexaQuad::edgeLocal2global(), oofem::FEI3dTetQuad::edgeLocal2global(), oofem::FEI3dTrQuad::edgeLocal2global(), oofem::FEI3dWedgeLin::edgeLocal2global(), oofem::FEI3dWedgeQuad::edgeLocal2global(), oofem::DummyFEInterpolation::evalN(), oofem::VTKExportModule::exportCellVars(), oofem::POIExportModule::exportIntVarAs(), oofem::MPElement::getBoundaryUnknownVector(), oofem::ContactElement::giveCharacteristicVector(), oofem::Line2BoundaryElement::giveCharacteristicVector(), oofem::StructuralElementEvaluator::giveCharacteristicVector(), oofem::StructuralInterfaceElement::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::MPElement::giveCharacteristicVectorFromBC(), oofem::SADGElement::giveCharacteristicVectorFromBC(), oofem::TMElement::giveCharacteristicVectorFromBC(), oofem::DummySpatialLocalizer::giveElementClosestToPoint(), oofem::BondLink3d::giveInternalForcesVector(), oofem::BondLink3dBoundary::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::LatticeBeam3d::giveInternalForcesVector(), oofem::LatticeBeam3dBoundary::giveInternalForcesVector(), oofem::LatticeLink3d::giveInternalForcesVector(), oofem::LIBeam3dBoundary::giveInternalForcesVector(), oofem::LTRSpaceBoundary::giveInternalForcesVector(), oofem::LumpedMassElement::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::SolidShell::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::Truss3dnl2::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::PhaseFieldElement::giveInternalForcesVector_u(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_u(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::Element::giveInternalStateAtNode(), oofem::Element::giveInternalStateAtSide(), oofem::Element::giveIPValue(), oofem::LinQuad3DPlaneStress::giveIPValue(), oofem::Material::giveIPValue(), oofem::RVEStokesFlow::giveIPValue(), oofem::TrPlanestressRotAllman3d::giveIPValue(), oofem::MisesMatNl::giveLocalNonlocalStiffnessContribution(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::KelvinChainMaterial::giveShrinkageStrainVector(), oofem::KelvinChainSolidMaterial::giveShrinkageStrainVector(), oofem::MaxwellChainMaterial::giveShrinkageStrainVector(), oofem::RheoChainMaterial::giveShrinkageStrainVector(), oofem::J2Mat::giveStressBackVector(), oofem::J2MPlasticMaterial::giveStressBackVector(), oofem::J2plasticMaterial::giveStressBackVector(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::DummyFEInterpolation::global2local(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionDev(), oofem::MixedGradientPressureNeumann::integrateVolTangent(), oofem::Quasicontinuum::intersectionTestSegmentSegment2D(), oofem::Quasicontinuum::intersectionTestSegmentTrianglePlucker3D(), oofem::DummyFEInterpolation::local2global(), oofem::FEI3dHexaConst::local2global(), oofem::FEI3dHexaLin::local2global(), oofem::FEI3dHexaQuad::local2global(), oofem::FEI3dTetLin::local2global(), oofem::FEI3dTetQuad::local2global(), oofem::FEI3dTrQuad::local2global(), oofem::FEI3dWedgeLin::local2global(), oofem::Parser::look(), oofem::Axisymm3d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::CCTPlate::NodalAveragingRecoveryMI_computeNodalValue(), oofem::DKTPlate::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Hexa21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LTRSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LTRSpaceBoundary::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LWedge::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Q27Space::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QQuad1_ht::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QTRSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QWedge::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QWedge_ht::NodalAveragingRecoveryMI_computeNodalValue(), oofem::tet21ghostsolid::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tet21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tr21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::TR_SHELL11::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Wedge_ht::NodalAveragingRecoveryMI_computeNodalValue(), oofem::CylindricalALM::solve(), oofem::FEI3dTrQuad::surfaceEvalBaseVectorsAt(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::FEI3dTetQuad::surfaceLocal2global(), oofem::FEI3dTrQuad::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::ExternalForceAssembler::vectorFromEdgeLoad(), oofem::ReferenceForceAssembler::vectorFromEdgeLoad(), oofem::VectorAssembler::vectorFromEdgeLoad(), oofem::LinearizedDilationForceAssembler::vectorFromElement(), oofem::VectorAssembler::vectorFromElement(), oofem::ExternalForceAssembler::vectorFromLoad(), oofem::ReferenceForceAssembler::vectorFromLoad(), oofem::VectorAssembler::vectorFromLoad(), oofem::ExternalForceAssembler::vectorFromNodeLoad(), oofem::ReferenceForceAssembler::vectorFromNodeLoad(), oofem::VectorAssembler::vectorFromNodeLoad(), oofem::ExternalForceAssembler::vectorFromSurfaceLoad(), oofem::ReferenceForceAssembler::vectorFromSurfaceLoad(), and oofem::VectorAssembler::vectorFromSurfaceLoad().

◆ computeNorm()

double oofem::FloatArray::computeNorm ( ) const

Computes the norm (or length) of the vector.

Returns
The Euclidean norm of the vector.

Definition at line 861 of file floatarray.C.

References computeSquaredNorm().

Referenced by oofem::MMALeastSquareProjection::__init(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::IntElSurfQuad1::computeAreaAround(), oofem::IntElSurfTr1::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::Truss3dnl2::computeDeformedLength(), oofem::StructuralPenaltyContactBoundaryCondition::computeInternalForcesFromContact(), oofem::Truss3dnl2::computeLength(), oofem::BasicGeometry::computeLineDistance(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::StructuralPenaltyContactBoundaryCondition::computeTangentFromContact(), oofem::Line::computeTangentialDistanceToEnd(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::FEI2dTrQuad::edgeEvaldNds(), oofem::FEI3dHexaQuad::edgeGiveTransformationJacobian(), oofem::FEI3dTrQuad::edgeGiveTransformationJacobian(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::FEI3dTrLin::giveArea(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::ScalarErrorIndicator::giveElementError(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::PlasticMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::FEI3dHexaQuad::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::FEInterpolation2d::global2local(), oofem::QCFullsolveddomain::isNodeInside(), oofem::ParallelContext::localNorm(), oofem::Tet1_3D_SUPG::LS_PCS_computeF(), oofem::TR21_2D_SUPG::LS_PCS_computeF(), oofem::QClinearStatic::nodeInFullSolvedDomainTest(), oofem::norm(), normalize_giveNorm(), oofem::LevelSetPCS::pcs_stage1(), oofem::PLMaterialForce::propagateInterface(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::Pdelta::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::FEI3dQuadLin::surfaceEvalNormal(), oofem::FEI3dTrLin::surfaceEvalNormal(), oofem::FEI3dTrQuad::surfaceEvalNormal(), oofem::Line::transformIntoPolar(), oofem::Quad10_2D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), and oofem::TR1_2D_SUPG::updateStabilizationCoeffs().

◆ computeSquaredNorm()

◆ containsOnlyZeroes()

◆ copySubVector()

void oofem::FloatArray::copySubVector ( const FloatArray & src,
int si )

Copy the given vector as sub-vector to receiver. The sub-vector values will be set to receivers values starting at at positions (si,...,si+src.size). The size of receiver will be adjusted, if necessary.

Parameters
srcSub-vector to be added
siDetermines the position (receiver's 1-based index) of first src value to be added.

Definition at line 886 of file floatarray.C.

References begin(), end(), FloatArray(), giveSize(), and resizeWithValues().

Referenced by oofem::Element::computeBoundaryVectorOf(), oofem::ActiveDof::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::ContactPair::computeVectorOf(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOfPrescribed(), oofem::Element::computeVectorOfPrescribed(), oofem::ActiveDof::giveUnknowns(), oofem::ActiveDof::giveUnknowns(), oofem::SlaveDof::giveUnknowns(), and oofem::SlaveDof::giveUnknowns().

◆ data() [1/2]

double * oofem::FloatArray::data ( )
inline

Definition at line 131 of file floatarray.h.

References values.

◆ data() [2/2]

const double * oofem::FloatArray::data ( ) const
inline

Definition at line 130 of file floatarray.h.

References values.

Referenced by oofem::BSplineInterpolation::giveKnotVector(), givePointer(), and givePointer().

◆ distance() [1/3]

double oofem::FloatArray::distance ( const FloatArray & iP1,
const FloatArray & iP2,
double & oXi,
double & oXiUnbounded ) const

Computes distance between the position represented by the reciever and a line segment represented by it's start point iP1 and it's end point iP2. The local coordinate oXi is in the range [0,1]

Author
Erik Svenning, August 2013.

Definition at line 556 of file floatarray.C.

References oofem::distance_square(), and FloatArray().

◆ distance() [2/3]

double oofem::FloatArray::distance ( const FloatArray & x) const

Computes the distance between position represented by receiver and position given as parameter.

Parameters
xCoordinate to calculate distance from.

Definition at line 551 of file floatarray.C.

References oofem::distance_square(), and FloatArray().

Referenced by oofem::PolygonLine::computeTangentialSignDist(), and oofem::distance().

◆ distance() [3/3]

double oofem::FloatArray::distance ( const FloatArray * x) const
inline
See also
distance

Definition at line 424 of file floatarray.h.

References distance(), and FloatArray().

Referenced by distance().

◆ distance_square() [1/2]

double oofem::FloatArray::distance_square ( const FloatArray & iP1,
const FloatArray & iP2,
double & oXi,
double & oXiUnbounded ) const

◆ distance_square() [2/2]

double oofem::FloatArray::distance_square ( const FloatArray & x) const

Computes the square of distance between position represented by receiver and position given as parameter.

Parameters
xCoordinate to calculate squared distance from.

Definition at line 599 of file floatarray.C.

References at(), FloatArray(), and oofem::min().

◆ dotProduct() [1/2]

double oofem::FloatArray::dotProduct ( const FloatArray & x) const

Computes the dot product (or inner product) of receiver and argument.

Parameters
xVector to contract to receiver.

Definition at line 524 of file floatarray.C.

References begin(), end(), FloatArray(), giveSize(), OOFEM_ERROR, and size().

Referenced by oofem::HOMExportModule::average(), oofem::FloatMatrix::beLocalCoordSys(), oofem::EnrichmentItem::calcPolarCoord(), oofem::MPlasticMaterial::closestPointReturn(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::FEContactSurface::computeContactPointLocalCoordinates_2d(), oofem::FEContactSurface::computeContactPointLocalCoordinates_3d(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::StructuralPenaltyContactBoundaryCondition::computeCovariantMetric(), oofem::EnrichmentFront::computeCrackTangent(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::FEContactPoint::computeCurvature(), oofem::IntElLine1PF::computeDamageAt(), oofem::PhaseFieldElement::computeDamageAt(), oofem::StructuralInterfaceElementPhF::computeDamageAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::TransportGradientNeumann::computeEta(), oofem::QTruss1dGradDamage::computeField(), oofem::Truss1dGradDamage::computeField(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::IntElLine1PF::computeFreeEnergy(), oofem::PhaseFieldElement::computeFreeEnergy(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::PolygonLine::computeIntersectionPoints(), oofem::BasicGeometry::computeLineDistance(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::GradDpElement::computeNonlocalCumulatedStrain(), oofem::GradientDamageElement::computeNonlocalDamageDrivingVariable(), oofem::PolygonLine::computeNormalSignDist(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::BaseMixedPressureElement::computePressure(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::Line::computeTangentialDistanceToEnd(), oofem::StructuralPenaltyContactBoundaryCondition::computeTractions(), oofem::TransportGradientDirichlet::computeXi(), oofem::dot(), oofem::LSpace::drawTriad(), oofem::EnrFrontIntersection::evaluateEnrFuncAt(), oofem::evalVolumeFraction(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::LinearElasticMaterial::giveEnergyDensity(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector_d(), oofem::BaseMixedPressureElement::giveInternalForcesVector_p(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::Element::giveLengthInDir(), oofem::LTRSpaceBoundary::giveLengthInDir(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::SlaveDof::giveUnknown(), oofem::SlaveDof::giveUnknown(), oofem::SolutionbasedShapeFunction::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::FEI3dLineLin::global2local(), oofem::ParallelContext::localDotProduct(), oofem::Tet1_3D_SUPG::LS_PCS_computeF(), oofem::TR21_2D_SUPG::LS_PCS_computeF(), oofem::TR21_2D_SUPG::LS_PCS_computeS(), oofem::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::LevelSetPCS::pcs_stage1(), oofem::Triangle::pointIsInTriangle(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::IntElLine1PF::solveForLocalDamage(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::XfemStructureManager::splitCracks(), oofem::XfemStructureManager::tipsHaveOppositeDirection(), oofem::LevelSetPCS::updatePosition(), oofem::FastMarchingMethod::updateTrialValue(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

◆ dotProduct() [2/2]

double oofem::FloatArray::dotProduct ( const FloatArray & x,
Index size ) const

Computes the dot product (or inner product) of receiver and argument.

Parameters
xVector to contract to receiver.
sizeNumber of elements to contract. May not be larger than

Definition at line 537 of file floatarray.C.

References begin(), FloatArray(), giveSize(), OOFEM_ERROR, and size().

◆ end() [1/2]

std::vector< double >::iterator oofem::FloatArray::end ( )
inline

◆ end() [2/2]

std::vector< double >::const_iterator oofem::FloatArray::end ( ) const
inline

Definition at line 110 of file floatarray.h.

◆ fromConcatenated()

◆ fromIniList()

FloatArray oofem::FloatArray::fromIniList ( std::initializer_list< double > ini)
static

◆ fromList()

FloatArray oofem::FloatArray::fromList ( const std::list< double > & l)
static

Definition at line 122 of file floatarray.C.

References FloatArray(), and resize().

Referenced by oofem::MPElement::getBoundaryUnknownVector().

◆ fromVector()

◆ giveIndexMaxElem()

int oofem::FloatArray::giveIndexMaxElem ( void )

◆ giveIndexMinElem()

int oofem::FloatArray::giveIndexMinElem ( void )

Returns index (between 1 and Size) of minimum element in the array

Definition at line 492 of file floatarray.C.

References giveSize().

Referenced by oofem::IsotropicDamageMaterial1::initDamaged().

◆ givePackSize()

int oofem::FloatArray::givePackSize ( DataStream & buff) const

◆ givePointer() [1/2]

double * oofem::FloatArray::givePointer ( )
inline

Definition at line 507 of file floatarray.h.

References data().

◆ givePointer() [2/2]

◆ giveSize()

Index oofem::FloatArray::giveSize ( ) const
inline

Returns the size of receiver.

Definition at line 261 of file floatarray.h.

References size().

Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::ParallelContext::accumulate(), add(), add(), oofem::PetscSparseMtrx::addDiagonal(), oofem::SparseMtrx::addDiagonal(), oofem::FloatMatrix::addSubVectorCol(), oofem::FloatMatrix::addSubVectorRow(), oofem::SymmetryBarrier::applyConstraint(), assemble(), assembleSquared(), oofem::ContactBoundaryCondition::assembleVector(), oofem::HOMExportModule::average(), oofem::Skyline::backSubstitutionWith(), oofem::SkylineUnsym::backSubstitutionWith(), beDifferenceOf(), beDifferenceOf(), oofem::FloatMatrix::beDyadicProductOf(), oofem::FloatMatrix::beLocalCoordSys(), oofem::FloatMatrix::beMatrixForm(), oofem::FloatMatrix::beMatrixFormOfStress(), beMaxOf(), beMinOf(), oofem::FloatMatrix::beNMatrixOf(), beProductOf(), beSubArrayOf(), beTProductOf(), beVectorProductOf(), oofem::PolylineNonlocalBarrier::calculateMinimumDistanceFromBoundary(), changeComponentOrder(), oofem::BeamElementErrorCheckingRule::check(), oofem::ElementErrorCheckingRule::check(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), checkSizeTowards(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::FRCFCMNL::computeAngleBetweenVectors(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TR1_2D_PFEM::computeBodyLoadVectorAt(), oofem::TR_SHELL11::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::Triangle::computeCenterOfCircumCircle(), oofem::KelvinChainMaterial::computeCharCoefficients(), oofem::MaxwellChainMaterial::computeCharCoefficients(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::RheoChainMaterial::computeDiscreteRelaxationFunction(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::ActiveDof::computeDofTransformation(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Hexa21Stokes::computeField(), oofem::Line2BoundaryElement::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::Tet1BubbleStokes::computeField(), oofem::Tr1BubbleStokes::computeField(), oofem::Tr21Stokes::computeField(), oofem::TransportElement::computeFlow(), oofem::PlasticMaterial::ComputeGradientVector(), oofem::MPlasticMaterial::computeGradientVector(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Structural3DElement::computeInitialStressMatrix(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::Lattice3d_mt::computeInternalSourceRhsVectorAt(), oofem::TransportElement::computeInternalSourceRhsVectorAt(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Line::computeIntersectionPoints(), oofem::J2Mat::computeKGradientVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::DofManager::computeM2LTransformation(), oofem::RigidArmNode::computeMasterContribution(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::StrainVector::computeMaxPrincipalDir(), oofem::LinearEdgeLoad::computeNArray(), oofem::PhaseFieldElement::computeNd_matrixAt(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::FRCFCMNL::computeNonlocalStressInFibersInUncracked(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::StrainVector::computePrincipalValues(), oofem::StressVector::computePrincipalValues(), oofem::StructuralMaterial::computePrincipalValues(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::PlasticMaterial::ComputeResidualVector(), oofem::MPlasticMaterial2::computeResidualVector(), oofem::MPlasticMaterial::computeResidualVector(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::B3Material::computeShrinkageStrainVector(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_dd(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::J2Mat::computeStrainHardeningVarsIncrement(), oofem::LIBeam3d2::computeStrainVector(), oofem::RheoChainMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVarsReducedGradient(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::LIBeam3dNL::computeTempCurv(), oofem::InteractionLoad::computeValueAt(), oofem::TF1::computeValueAt(), oofem::ContactPair::computeVectorOf(), oofem::StructuralMaterial::computeVonMisesStress(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::BoundingBox::contains(), oofem::OctantRecT< T > *::containsPoint(), oofem::StressStrainBaseVector::convertFromFullForm(), copySubVector(), oofem::FloatMatrix::copySubVectorRow(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), oofem::CylindricalALM::do_lineSearch(), oofem::GPExportModule::doOutput(), oofem::HOMExportModule::doOutput(), oofem::VTKPFEMXMLExportModule::doOutput(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::MatlabExportModule::doOutputIntegrationPointFields(), dotProduct(), dotProduct(), oofem::FEI3dWedgeLin::edgeLocal2global(), oofem::FEI3dWedgeQuad::edgeLocal2global(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::tet21ghostsolid::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::Tet21Stokes::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::ScalarFunction::eval(), oofem::CalculatorFunction::evaluate(), oofem::Function::evaluate(), oofem::DofManValueField::evaluateAt(), oofem::ExpressionField::evaluateAt(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::UniformGridField::evaluateAt(), oofem::Function::evaluateAtTime(), oofem::Delamination::evaluateEnrFuncAt(), oofem::DamagedNeighborLayered::evaluateFailureCriteria(), oofem::MixedGradientPressureWeakPeriodic::evaluateTractionBasisFunctions(), oofem::VTKExportModule::exportCellVars(), oofem::VTKExportModule::exportIntVarAs(), oofem::VTKXMLLatticeExportModule::exportPrimaryVars(), oofem::VTKXMLPeriodicExportModule::exportPrimaryVars(), oofem::VTKExportModule::exportPrimVarAs(), oofem::FloatArrayF< N >::FloatArrayF(), oofem::VTKBaseExportModule::getCellVariableFromIS(), oofem::PythonExpression::getDict(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKBaseExportModule::getNodalVariableFromIS(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLXFemExportModule::getNodalVariableFromXFEMST(), oofem::BeamElementErrorCheckingRule::getValue(), oofem::ElementErrorCheckingRule::getValue(), oofem::ExportRegion::getVertices(), oofem::InitialCondition::give(), oofem::PrescribedGradient::give(), oofem::UserDefDirichletBC::give(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::MFrontUserMaterial::give3dMaterialStiffnessMatrix(), oofem::Skyline::giveAllocatedSize(), oofem::UnstructuredGridField::Cell::giveBoundingBox(), oofem::OctantRec::giveChildContainingPoint(), oofem::OctantRecT< T > *::giveChildContainingPoint(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::DofManager::giveCoordinate(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::Beam3d::giveEndForcesVector(), oofem::ContactBoundaryCondition::giveExportData(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::TransportMaterial::giveFluxVector(), oofem::StructuralMaterial::giveFullSymVectorForm(), oofem::StructuralMaterial::giveFullVectorForm(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam2d(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam3d(), oofem::SimpleCrossSection::giveGeneralizedStress_Plate(), oofem::SimpleCrossSection::giveGeneralizedStress_Shell(), oofem::StructuralSlipFE2Material::giveHomogenizedFields(), giveIndexMaxElem(), giveIndexMinElem(), oofem::BondLink3d::giveInternalForcesVector(), oofem::LIBeam3dBoundary::giveInternalForcesVector(), oofem::LTRSpaceBoundary::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::Truss3dnl2::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector_d(), oofem::GradientDamageElement::giveInternalForcesVector_u(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::StructuralMaterial::giveIPValue(), oofem::LatticeDamage::giveLatticeStress3d(), oofem::LatticeDamageViscoelastic::giveLatticeStress3d(), oofem::LatticeLinearElastic::giveLatticeStress3d(), oofem::LatticePlasticityDamageViscoelastic::giveLatticeStress3d(), oofem::LatticeViscoelastic::giveLatticeStress3d(), oofem::LTRSpaceBoundary::giveLengthInDir(), oofem::CCTPlate3d::giveLocalCoordinates(), oofem::DKTPlate3d::giveLocalCoordinates(), oofem::RerShell::giveLocalCoordinates(), oofem::TR_SHELL11::giveLocalCoordinates(), oofem::TrPlaneStrRot3d::giveLocalCoordinates(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::PrescribedGradientBCPeriodic::giveMasterDof(), oofem::NodalRecoveryModel::giveNodalVector(), oofem::Skyline::giveNumberOfNonZeros(), oofem::PrescribedDispSlipBCDirichletRC::giveOnConcrete(), givePackSize(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FCMMaterial::giveRealStressVector(), oofem::IsotropicDamageMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::M1Material::giveRealStressVector_3d(), oofem::StructuralFE2Material::giveRealStressVector_3d(), oofem::StructuralMaterial::giveReducedSymVectorForm(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::StructuralSlipFE2Material::giveSensitivities(), oofem::Shell7Base::giveShellExportData(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::MixedGradientPressureDirichlet::giveUnknown(), oofem::tet21ghostsolid::giveUnknownData(), oofem::ActiveDof::giveUnknowns(), oofem::ActiveDof::giveUnknowns(), oofem::SlaveDof::giveUnknowns(), oofem::SlaveDof::giveUnknowns(), oofem::Node::giveUpdatedCoordinates(), oofem::FEI3dHexaQuad::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::CompCol_ICPreconditioner::ICSolve(), oofem::DynCompRow::ILUPsolve(), oofem::DynCompRow::ILUPtrans_solve(), oofem::DynCompRow::ILUPYourself(), oofem::FiberedCrossSection::imposeStrainConstrainsOnGradient(), oofem::LayeredCrossSection::imposeStrainConstrainsOnGradient(), oofem::StructuralCrossSection::imposeStrainConstrainsOnGradient(), oofem::FiberedCrossSection::imposeStressConstrainsOnGradient(), oofem::LayeredCrossSection::imposeStressConstrainsOnGradient(), oofem::StructuralCrossSection::imposeStressConstrainsOnGradient(), oofem::MazarsMaterial::initDamaged(), oofem::SlaveDof::initialize(), oofem::AnisotropicLinearElasticMaterial::initializeFrom(), oofem::LevelSetPCS::initializeFrom(), oofem::Node::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::PolygonLine::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::UnstructuredGridField::initOctree(), oofem::OctreeSpatialLocalizer::insertElementIntoOctree(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), oofem::HybridEI::interpGradLevelSet(), oofem::HybridEI::interpLevelSet(), oofem::HybridEI::interpLevelSetTangential(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::MMAShapeFunctProjection::interpolateIntVarAt(), oofem::FEI2dQuadQuad::local2global(), oofem::FEI3dHexaQuad::local2global(), oofem::ParallelContext::localDotProduct(), oofem::ParallelContext::localNorm(), oofem::ls2fit(), oofem::VTKBaseExportModule::makeFullTensorForm(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::TriangleMesherInterface::meshPSLG(), oofem::MDM::MMI_map(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::IntElLine1::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha2(), operator<<, oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputGradient(), oofem::GnuplotExportModule::outputXFEM(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::MisesMat::performPlasticityReturn(), oofem::FloatMatrix::plus_Nt_a_otimes_b_B(), oofem::FloatMatrix::plusDyadSymmUpper(), oofem::FloatMatrix::plusDyadUnsym(), plusProduct(), oofem::Triangle::pointIsInTriangle(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::LineDistributedSpring::printOutputAt(), oofem::NodalSpringElement::printOutputAt(), oofem::TransientTransportProblem::printOutputAt(), printYourself(), printYourselfToFile(), oofem::PLCrackPrescribedDir::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), oofem::PetscSparseMtrx::scatterL2G(), oofem::FloatMatrix::setColumn(), oofem::PrescribedDispSlipHomogenization::setDispField(), oofem::PrescribedDispSlipHomogenization::setDispGradient(), oofem::UniformGridField::setGeometry(), oofem::BoundingBox::setOrigin(), oofem::PrescribedGenStrainShell7::setPrescribedGenStrainShell7Voigt(), oofem::PrescribedGradientHomogenization::setPrescribedGradientVoigt(), oofem::PrescribedDispSlipHomogenization::setSlipField(), oofem::PrescribedDispSlipHomogenization::setSlipGradient(), oofem::FCMMaterialStatus::setTempNormalCrackStrainVector(), oofem::GaussIntegrationRule::SetUpPointsOn3dDegShellLayers(), oofem::GaussIntegrationRule::SetUpPointsOnCubeLayers(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), oofem::GaussIntegrationRule::SetUpPointsOnWedgeLayers(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::CompCol_ILUPreconditioner::solve(), oofem::CylindricalALM::solve(), oofem::DiagPreconditioner::solve(), oofem::DynamicRelaxationSolver::solve(), oofem::FETISolver::solve(), oofem::IMLSolver::solve(), oofem::LineSearchNM::solve(), oofem::MKLPardisoSolver::solve(), oofem::NRSolver::solve(), oofem::PardisoProjectOrgSolver::solve(), oofem::PetscSolver::solve(), oofem::SpoolesSolver::solve(), oofem::StaggeredSolver::solve(), oofem::SuperLUSolver::solve(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::TestProblem::solveYourselfAt(), oofem::SpatialLocalizerInterface::SpatialLocalizerI_BBoxContainsPoint(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::StressStrainBaseVector::StressStrainBaseVector(), subtract(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::OctantRec::testBoundingBox(), oofem::OctantRecT< T > *::testBoundingSphere(), oofem::CompCol::times(), oofem::DynCompCol::times(), oofem::DynCompRow::times(), oofem::PetscSparseMtrx::times(), oofem::Skyline::times(), oofem::SkylineUnsym::times(), oofem::SymCompCol::times(), oofem::CompCol::timesT(), oofem::DynCompCol::timesT(), oofem::DynCompRow::timesT(), oofem::PetscSparseMtrx::timesT(), oofem::SkylineUnsym::timesT(), oofem::CompCol_ILUPreconditioner::trans_solve(), oofem::DiagPreconditioner::trans_solve(), oofem::TransientTransportProblem::updateComponent(), oofem::FreeWarping::updateComputedResults(), oofem::FCMMaterial::updateCrackStatus(), oofem::PFEM::updateDofUnknownsDictionary(), oofem::PFEM::updateDofUnknownsDictionaryVelocities(), oofem::TransientTransportProblem::updateInternalRHS(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydrationModel::updateInternalState(), oofem::TransportMaterial::updateInternalState(), oofem::Shell7Base::updateLayerTransvShearStressesSR(), oofem::Shell7Base::updateLayerTransvStressesSR(), oofem::SolutionbasedShapeFunction::whichBoundary(), oofem::VTKXMLLatticeExportModule::writeCellVarsCross(), oofem::ErrorCheckingExportModule::writeCheck(), oofem::VTKXMLExportModule::writeIntVars(), oofem::VTKXMLExportModule::writeVTKCellData(), oofem::VTKXMLLatticeExportModule::writeVTKPieceCross(), oofem::VTKXMLExportModule::writeVTKPieceProlog(), oofem::VTKXMLExportModule::writeVTKPointData(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), oofem::UniformGridField::xyz2ijk(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

◆ isAllFinite()

bool oofem::FloatArray::isAllFinite ( ) const

Returns true if no element is NAN or infinite.

Definition at line 195 of file floatarray.C.

Referenced by oofem::isfinite(), and oofem::LSPrimaryVariableMapper::mapPrimaryVariables().

◆ isEmpty()

◆ isNotEmpty()

◆ negated()

void oofem::FloatArray::negated ( )

Switches the sign of every coefficient of receiver.

Returns
receiver.

Definition at line 752 of file floatarray.C.

Referenced by oofem::StokesFlowVelocityHomogenization::applyPressureGradient(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DGProblem::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::TransverseReinfConstraint::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorStress(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::TransportElement::computeFlow(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::CBSElement::computePrescribedTermsI(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::LEPlic::doCellDLS(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::NonLinearStatic::proceedStep(), oofem::LinearStability::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), and oofem::PFEMPressureRhsAssembler::vectorFromElement().

◆ normalize()

void oofem::FloatArray::normalize ( )

Normalizes receiver. Euclidean norm is used, after operation receiver will have this norm equal to 1.0.

Definition at line 845 of file floatarray.C.

References normalize_giveNorm().

Referenced by oofem::FloatMatrix::beLocalCoordSys(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::Lattice3d::computeCrossSectionProperties(), oofem::Lattice3d_mt::computeCrossSectionProperties(), oofem::LatticeBeam3d::computeCrossSectionProperties(), oofem::TMElement::computeFluxLBToLRotationMatrix(), oofem::UPElement::computeFluxLBToLRotationMatrix(), oofem::BondLink3d::computeGeometryProperties(), oofem::BondLink3dBoundary::computeGeometryProperties(), oofem::LatticeLink3d::computeGeometryProperties(), oofem::LatticeLink3dBoundary::computeGeometryProperties(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::InterfaceElem2dLin::computeGtoLRotationMatrix(), oofem::InterfaceElem2dQuad::computeGtoLRotationMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::TR_SHELL11::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::CCTPlate::computeMidPlaneNormal(), oofem::DKTPlate::computeMidPlaneNormal(), oofem::QDKTPlate::computeMidPlaneNormal(), oofem::Quad1PlateSubSoil::computeMidPlaneNormal(), oofem::Tria1PlateSubSoil::computeMidPlaneNormal(), oofem::PrescribedDispSlipBCNeumannRC::computeRebarDyad(), oofem::IntElLine1PF::computeTransformationMatrixAt(), oofem::IntElSurfQuad1::computeTransformationMatrixAt(), oofem::IntElSurfTr1::computeTransformationMatrixAt(), oofem::GravityPressure::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::LEPlic::doCellDLS(), oofem::Lattice2dBoundary::drawRawCrossSections(), oofem::Lattice2dBoundary::drawSpecial(), oofem::LSpace::drawTriad(), oofem::CohesiveSurface3d::evaluateLocalCoordinateSystem(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::Lattice2d::giveCrossSectionCoordinates(), oofem::Lattice2d_mt::giveCrossSectionCoordinates(), oofem::Lattice2dBoundary::giveCrossSectionCoordinates(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::Structural2DElement::giveMaterialOrientationAt(), oofem::Structural3DElement::giveMaterialOrientationAt(), oofem::PrescribedGradientBCWeak::giveMirroredPointOnGammaMinus(), oofem::PrescribedGradientBCWeak::giveMirroredPointOnGammaPlus(), oofem::PolygonLine::giveNormal(), oofem::PolygonLine::giveTangent(), oofem::PolygonLine::giveTips(), oofem::PrescribedGradientBCWeak::giveTractionElNormal(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::NCPrincipalStrain::nucleateEnrichmentItems(), oofem::NCPrincipalStress::nucleateEnrichmentItems(), oofem::Triangle::pointIsInTriangle(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::FastMarchingMethod::updateTrialValue(), and oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule().

◆ normalize_giveNorm()

◆ operator()() [1/2]

double & oofem::FloatArray::operator() ( Index i)
inline

Coefficient access function. Returns value of coefficient at given position of the receiver. Provides 0-based indexing access.

Parameters
iPosition of coefficient in array.

Definition at line 137 of file floatarray.h.

References operator[]().

◆ operator()() [2/2]

const double & oofem::FloatArray::operator() ( Index i) const
inline

Coefficient access function. Returns value of coefficient at given position of the receiver. Provides 0-based indexing access.

Parameters
iPosition of coefficient in array.

Definition at line 150 of file floatarray.h.

References operator[]().

◆ operator=() [1/5]

FloatArray & oofem::FloatArray::operator= ( const double & val)

Assignment of scalar to all components of receiver.

Definition at line 952 of file floatarray.C.

References begin(), and FloatArray().

◆ operator=() [2/5]

FloatArray & oofem::FloatArray::operator= ( const FloatArray & src)
inline

Assignment operator.

Definition at line 125 of file floatarray.h.

References FloatArray(), and values.

◆ operator=() [3/5]

template<std::size_t N>
FloatArray & oofem::FloatArray::operator= ( const FloatArrayF< N > & src)
inline

Assign from fixed size array.

Definition at line 188 of file floatarray.h.

References FloatArray(), and oofem::FloatArrayF< N >::size().

◆ operator=() [4/5]

FloatArray & oofem::FloatArray::operator= ( FloatArray && src)
inlinenoexcept

Move operator.

Definition at line 127 of file floatarray.h.

References FloatArray(), and values.

◆ operator=() [5/5]

FloatArray & oofem::FloatArray::operator= ( std ::initializer_list< double > list)
inline

Assignment operator.

Definition at line 185 of file floatarray.h.

References FloatArray(), and fromIniList().

◆ operator[]() [1/2]

double & oofem::FloatArray::operator[] ( Index i)
inline

Definition at line 138 of file floatarray.h.

References checkBounds(), and values.

Referenced by operator()(), and operator()().

◆ operator[]() [2/2]

const double & oofem::FloatArray::operator[] ( Index i) const
inline

Definition at line 151 of file floatarray.h.

References checkBounds(), and values.

◆ plusProduct()

void oofem::FloatArray::plusProduct ( const FloatMatrix & b,
const FloatArray & s,
double dV )

Adds the product \( b^T . s dV \). If the receiver's size is zero, it adjusts its size.

Parameters
bMatrix b in the equation.
sArray s in the equation.
dVScalar dV in the equation.

Definition at line 288 of file floatarray.C.

References at(), oofem::FloatMatrix::at(), FloatArray(), FloatMatrix, oofem::FloatMatrix::giveNumberOfColumns(), oofem::FloatMatrix::giveNumberOfRows(), givePointer(), oofem::FloatMatrix::givePointer(), giveSize(), isEmpty(), OOFEM_ERROR, resize(), and sum().

Referenced by oofem::SUPGElement2::computeAdvectionTerm_MB(), oofem::SUPGElement2::computeAdvectionTerm_MC(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::SUPGElement2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::TransportElement::computeInternalForcesVector(), oofem::SUPGElement2::computeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::TransportElement::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computeSectionalForces(), oofem::Shell7Base::computeSectionalForcesAt(), oofem::Shell7BaseXFEM::computeSectionalForcesAt(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::Shell7Base::computeTractionForce(), oofem::BondLink3d::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::LIBeam3dBoundary::giveInternalForcesVector(), oofem::LTRSpaceBoundary::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::QPlaneStress2dSlip::giveInternalForcesVector(), oofem::QTrPlaneStress2dSlip::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::SolidShell::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::Truss3dnl2::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector_d(), oofem::PhaseFieldElement::giveInternalForcesVector_u(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_u(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::MisesMatNl::giveLocalNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionDev(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), oofem::MixedGradientPressureNeumann::integrateVolTangent(), and oofem::LinearizedDilationForceAssembler::vectorFromElement().

◆ power()

void oofem::FloatArray::power ( const double exponent)

Raise each element to its power

Parameters
exponentAn exponent.

Definition at line 1173 of file floatarray.C.

Referenced by oofem::TransportElement::computeBoundaryEdgeLoadVector(), and oofem::TransportElement::computeBoundarySurfaceLoadVector().

◆ printYourself() [1/2]

◆ printYourself() [2/2]

void oofem::FloatArray::printYourself ( const std::string & name) const
virtual

Print receiver on stdout with custom name.

Parameters
nameDisplay name of reciever.

Definition at line 774 of file floatarray.C.

◆ printYourselfToFile()

void oofem::FloatArray::printYourselfToFile ( const std::string filename,
const bool showDimensions = true ) const
virtual

Print receiver to file

Parameters
filenameName of recieving file.
showDimensionsDetermins if dimesions should be included in output

Definition at line 785 of file floatarray.C.

References giveSize(), and OOFEM_ERROR.

◆ product()

double oofem::FloatArray::product ( ) const

Computes the product of receiver values.

Returns
Product of receiver.

Definition at line 880 of file floatarray.C.

References begin(), and end().

Referenced by oofem::product().

◆ pY()

void oofem::FloatArray::pY ( ) const
virtual

◆ resize()

void oofem::FloatArray::resize ( Index s)

Resizes receiver towards requested size. Array is zeroed.

Parameters
sNew size.
Todo
Change to this (faster)

Definition at line 94 of file floatarray.C.

References _DBG, and values.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMALeastSquareProjection::__mapVariable(), oofem::ParallelContext::accumulate(), oofem::Quasicontinuum::applyApproach3(), oofem::NonStationaryTransportProblem::applyIC(), oofem::PFEM::applyIC(), oofem::SUPG::applyIC(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::NonLinearStatic::assembleIncrementalReferenceLoadVectors(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::DIIDynamic::assembleLoadVector(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::EngngModel::assembleVector(), oofem::HOMExportModule::average(), beDifferenceOf(), oofem::FEInterpolation1d::boundaryEvalN(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), checkSizeTowards(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MC(), oofem::Triangle::computeBarycentrCoor(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue1D(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubVectorAt(), oofem::TransportElement::computeBCVectorAt(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::TransportElement::computeBodyBCSubVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::TR1_2D_PFEM::computeBodyLoadVectorAt(), oofem::TR_SHELL01::computeBodyLoadVectorAt(), oofem::TR_SHELL11::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::TMElement::computeBoundaryEdgeLoadVector(), oofem::UPElement::computeBoundaryEdgeLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::TMElement::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::UPElement::computeBoundarySurfaceLoadVector(), oofem::Element::computeBoundaryVectorOf(), oofem::Triangle::computeCenterOfCircumCircle(), oofem::FreeWarping::computeCenterOfGravity(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::TR1_2D_CBS::computeCorrectionRhs(), oofem::IntElSurfQuad1::computeCovarBaseVectorsAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::MazarsMaterial::computeDamageParam(), oofem::TR1_2D_CBS::computeDensityRhsPressureTerms(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::TR1_2D_SUPG::computeDeviatoricStrain(), oofem::TR1_2D_PFEM::computeDeviatoricStress(), oofem::TR1_2D_PFEM::computeDeviatoricStressDivergence(), oofem::TR1_2D_CBS::computeDiagonalMassMtrx(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::RheoChainMaterial::computeDiscreteRelaxationFunction(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::ActiveDof::computeDofTransformation(), oofem::Dof::computeDofTransformation(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::FRCFCMNL::computeElementCentroid(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::MazarsMaterial::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::StaticStructural::computeExternalLoadReactionContribution(), oofem::StructuralEngngModel::computeExternalLoadReactionContribution(), oofem::Hexa21Stokes::computeField(), oofem::Line2BoundaryElement::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::Tet1BubbleStokes::computeField(), oofem::Tr1BubbleStokes::computeField(), oofem::Tr21Stokes::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::Tr_Warp::computeFirstMomentOfArea(), oofem::Lattice3d_mt::computeFlow(), oofem::TransportElement::computeFlow(), oofem::BaseMixedPressureElement::computeForceLoadVector(), oofem::Beam3d::computeGlobalCoordinates(), oofem::Beam3d::computeGlobalCoordinates(), oofem::BondLink3d::computeGlobalCoordinates(), oofem::CCTPlate3d::computeGlobalCoordinates(), oofem::DKTPlate3d::computeGlobalCoordinates(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::IntElSurfQuad1::computeGlobalCoordinates(), oofem::IntElSurfTr1::computeGlobalCoordinates(), oofem::InterfaceElement3dTrLin::computeGlobalCoordinates(), oofem::Lattice2d::computeGlobalCoordinates(), oofem::Lattice2d_mt::computeGlobalCoordinates(), oofem::Lattice3d::computeGlobalCoordinates(), oofem::Lattice3d_mt::computeGlobalCoordinates(), oofem::LatticeBeam3d::computeGlobalCoordinates(), oofem::LatticeBeam3dBoundary::computeGlobalCoordinates(), oofem::LatticeLink3d::computeGlobalCoordinates(), oofem::LIBeam2d::computeGlobalCoordinates(), oofem::LIBeam2dNL::computeGlobalCoordinates(), oofem::LIBeam3d2::computeGlobalCoordinates(), oofem::LIBeam3d::computeGlobalCoordinates(), oofem::LIBeam3dBoundary::computeGlobalCoordinates(), oofem::LIBeam3dNL2::computeGlobalCoordinates(), oofem::LIBeam3dNL::computeGlobalCoordinates(), oofem::MITC4Shell::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::Truss2d::computeGlobalCoordinates(), oofem::MPlasticMaterial::computeGradientVector(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::Lattice3d_mt::computeInternalSourceRhsVectorAt(), oofem::TransportElement::computeInternalSourceRhsVectorAt(), oofem::CemhydMat::computeInternalSourceVector(), oofem::HydratingConcreteMat::computeInternalSourceVector(), oofem::NlIsoMoistureMaterial::computeInternalSourceVector(), oofem::TR21_2D_SUPG::computeIntersection(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::DruckerPragerCutMat::computeKGradientVector(), oofem::J2Mat::computeKGradientVector(), oofem::Masonry02::computeKGradientVector(), oofem::LatticeNeumannCouplingNode::computeLoadCouplingContribution(), oofem::DofManager::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::NlDEIDynamic::computeLoadVector(), oofem::PFEMElement::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::TMElement::computeLoadVector(), oofem::TR1_2D_SUPG::computeLoadVector(), oofem::TR1_2D_SUPG_AXI::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::LatticeNeumannCouplingNode::computeLoadVectorAt(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::CCTPlate3d::computeLocalCoordinates(), oofem::DKTPlate3d::computeLocalCoordinates(), oofem::Lattice2d_mt::computeLocalCoordinates(), oofem::Lattice3d_mt::computeLocalCoordinates(), oofem::MITC4Shell::computeLocalCoordinates(), oofem::RerShell::computeLocalCoordinates(), oofem::BaseMixedPressureElement::computeLocForceLoadVector(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::LinearEdgeLoad::computeNArray(), oofem::XfemElementInterface::computeNCohesive(), oofem::TR1_2D_SUPG::computeNMtrx(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::NeumannMomentLoad::computeNormal(), oofem::PhaseFieldElement::computeNStress_d(), oofem::TR1_2D_CBS::computeNumberOfNodalPrescribedTractionPressureContributions(), oofem::WeakPeriodicBoundaryCondition::computeOrthogonalBasis(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::MDM::computePDC(), oofem::AnisotropicDamageMaterial::computePlaneStressSigmaZ(), oofem::AnisotropicDamageMaterial::computePlaneStressStrain(), oofem::B3SolidMaterial::computePointShrinkageStrainVector(), oofem::MMALeastSquareProjection::computePolynomialTerms(), oofem::SPRNodalRecoveryModel::computePolynomialTerms(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computePressureForceAt(), oofem::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::StrainVector::computePrincipalValues(), oofem::StressVector::computePrincipalValues(), oofem::StructuralMaterial::computePrincipalValues(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), oofem::TR21_2D_SUPG::computeQuadraticFunct(), oofem::LIBeam3dNL2::computeQuaternionFromRotMtrx(), oofem::StructuralEngngModel::computeReaction(), oofem::PrescribedDispSlipBCNeumannRC::computeRebarDyad(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::MPlasticMaterial2::computeResidualVector(), oofem::MPlasticMaterial::computeResidualVector(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::Shell7Base::computeSectionalForces(), oofem::DKTPlate::computeShearForces(), oofem::B3Material::computeShrinkageStrainVector(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::DruckerPragerCutMat::computeStrainHardeningVarsIncrement(), oofem::J2Mat::computeStrainHardeningVarsIncrement(), oofem::Masonry02::computeStrainHardeningVarsIncrement(), oofem::HTSelement::computeStrainVector(), oofem::LIBeam3dNL2::computeStrainVector(), oofem::LIBeam3dNL::computeStrainVector(), oofem::StructuralElement::computeStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::Beam2d::computeStrainVectorInLayer(), oofem::CCTPlate::computeStrainVectorInLayer(), oofem::DKTPlate::computeStrainVectorInLayer(), oofem::LIBeam2d::computeStrainVectorInLayer(), oofem::LIBeam2dNL::computeStrainVectorInLayer(), oofem::QDKTPlate::computeStrainVectorInLayer(), oofem::RerShell::computeStrainVectorInLayer(), oofem::TR_SHELL11::computeStrainVectorInLayer(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::DruckerPragerCutMat::computeStressGradientVector(), oofem::J2Mat::computeStressGradientVector(), oofem::J2MPlasticMaterial::computeStressGradientVector(), oofem::Masonry02::computeStressGradientVector(), oofem::RankinePlasticMaterial::computeStressGradientVector(), oofem::SteelRelaxMat::computeStressRelaxationStrainVector(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::HTSelement::computeStressVector(), oofem::LineDistributedSpring::computeStressVector(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::HTSelement::computeSvMatrixAt(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::B3SolidMaterial::computeTotalAverageShrinkageStrainVector(), oofem::Shell7Base::computeTractionForce(), oofem::StructuralPenaltyContactBoundaryCondition::computeTractions(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::BondLink3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundaryMembrane::computeTransformationMatrix(), oofem::LIBeam3dBoundaryPlate::computeTransformationMatrix(), oofem::LIBeam3dBoundaryVoigt::computeTransformationMatrix(), oofem::LTRSpaceBoundary::computeTransformationMatrix(), oofem::LTRSpaceBoundaryMembrane::computeTransformationMatrix(), oofem::LTRSpaceBoundaryPlate::computeTransformationMatrix(), oofem::LTRSpaceBoundaryVoigt::computeTransformationMatrix(), oofem::HTSelement::computeUvMatrixAt(), oofem::BoundaryLoad::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::TF1::computeValueAt(), oofem::UserDefinedTemperatureField::computeValueAt(), oofem::Load::computeValues(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOf(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::Element::computeVectorOfPrescribed(), oofem::Element::computeVectorOfPrescribed(), oofem::QTrPlaneStrainP1::computeVolumetricBmatrixAt(), oofem::Quad1PlaneStrainP1::computeVolumetricBmatrixAt(), oofem::LIBeam3dNL2::computeXdVector(), oofem::LIBeam3dNL::computeXdVector(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::CylindricalALM::convertHPCMap(), oofem::StressStrainBaseVector::convertToFullForm(), oofem::FloatMatrix::copyColumn(), oofem::StructuralFE2MaterialStatus::copyStateVariables(), oofem::TSplineInterpolation::createLocalKnotVector(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::TSplineInterpolation::dersBasisFunction(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::GPInitModule::doInit(), oofem::StructuralElementEvaluator::drawIGAPatchDeformedGeometry, oofem::Lattice2dBoundary::drawRawCrossSections(), oofem::IGAElement::drawRawGeometry(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::Lattice2dBoundary::drawSpecial(), oofem::PlaneStress2d::drawSpecial(), oofem::Quad1PlaneStrain::drawSpecial(), oofem::FEI2dLineHermite::edgeEvald2Nds2(), oofem::FEI2dLineConst::edgeEvaldNds(), oofem::FEI2dLineHermite::edgeEvaldNds(), oofem::FEI2dLineLin::edgeEvaldNds(), oofem::FEI2dLineQuad::edgeEvaldNds(), oofem::FEI3dHexaConst::edgeEvaldNdxi(), oofem::FEI3dHexaLin::edgeEvaldNdxi(), oofem::FEI3dQuadLin::edgeEvaldNdxi(), oofem::FEI3dTrLin::edgeEvaldNdxi(), oofem::FEI3dTrQuad::edgeEvaldNdxi(), oofem::FEI2dTrConst::edgeEvalN(), oofem::FEI3dHexaLin::edgeEvalN(), oofem::FEI3dHexaQuad::edgeEvalN(), oofem::FEI3dQuadLin::edgeEvalN(), oofem::FEI3dTetLin::edgeEvalN(), oofem::FEI3dTetQuad::edgeEvalN(), oofem::FEI3dTrLin::edgeEvalN(), oofem::FEI3dTrQuad::edgeEvalN(), oofem::FEI3dWedgeLin::edgeEvalN(), oofem::FEI3dWedgeQuad::edgeEvalN(), oofem::FEI2dLineConst::edgeEvalNormal(), oofem::FEI2dLineHermite::edgeEvalNormal(), oofem::FEI2dLineLin::edgeEvalNormal(), oofem::FEI2dLineQuad::edgeEvalNormal(), oofem::FEI2dQuadQuad::edgeEvalNormal(), oofem::FEI2dTrQuad::edgeEvalNormal(), oofem::FEI2dQuadLin::edgeLocal2global(), oofem::FEI2dQuadQuad::edgeLocal2global(), oofem::FEI2dTrConst::edgeLocal2global(), oofem::FEI2dTrLin::edgeLocal2global(), oofem::FEI2dTrQuad::edgeLocal2global(), oofem::FEI3dHexaLin::edgeLocal2global(), oofem::FEI3dQuadLin::edgeLocal2global(), oofem::FEI3dTetLin::edgeLocal2global(), oofem::FEI3dTrLin::edgeLocal2global(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::tet21ghostsolid::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::Tet21Stokes::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::ZZErrorEstimator::estimateError(), oofem::Parser::eval(), oofem::NURBSInterpolation::evaldNdx(), oofem::BSplineInterpolation::evalN(), oofem::FEI1dHermite::evalN(), oofem::FEI1dLin::evalN(), oofem::FEI1dQuad::evalN(), oofem::FEI2dLineConst::evalN(), oofem::FEI2dLineHermite::evalN(), oofem::FEI2dLineLin::evalN(), oofem::FEI2dLineQuad::evalN(), oofem::FEI2dQuadBiQuad::evalN(), oofem::FEI2dQuadConst::evalN(), oofem::FEI3dHexaQuad::evalN(), oofem::FEI3dHexaTriQuad::evalN(), oofem::FEI3dLineLin::evalN(), oofem::FEI3dTetLin::evalN(), oofem::FEI3dTetQuad::evalN(), oofem::FEI3dWedgeLin::evalN(), oofem::FEI3dWedgeQuad::evalN(), oofem::NURBSInterpolation::evalN(), oofem::TSplineInterpolation::evalN(), oofem::BDalphaPiTerm::evaluate(), oofem::BTdSigmadT::evaluate(), oofem::CalculatorFunction::evaluate(), oofem::DofManValueField::evaluateAt(), oofem::VoxelVOFField::evaluateAt(), oofem::VoxelVOFField::evaluateAt(), oofem::DiscontinuousFunction::evaluateEnrFuncDerivAt(), oofem::HeavisideFunction::evaluateEnrFuncDerivAt(), oofem::RampFunction::evaluateEnrFuncDerivAt(), oofem::MixedGradientPressureWeakPeriodic::evaluateTractionBasisFunctions(), oofem::VTKExportModule::exportIntVarAs(), oofem::VTKXMLLatticeExportModule::exportIntVars(), oofem::VTKXMLPeriodicExportModule::exportIntVars(), oofem::VTKXMLLatticeExportModule::exportPrimaryVars(), oofem::VTKXMLPeriodicExportModule::exportPrimaryVars(), oofem::VTKExportModule::exportPrimVarAs(), oofem::HuertaErrorEstimator::extractVectorFrom(), oofem::SkylineUnsym::factorized(), oofem::Beam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LIBeam3d2::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LIBeam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LevelSetPCS::FMMReinitialization(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase2D(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase3D(), fromIniList(), fromList(), fromVector(), oofem::PythonExpression::getArray(), oofem::VTKBaseExportModule::getCellVariableFromIS(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKBaseExportModule::getNodalVariableFromIS(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLXFemExportModule::getNodalVariableFromXFEMST(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::PFEMElement::giveCharacteristicVector(), oofem::StructuralElement::giveCharacteristicVector(), oofem::SUPGElement2::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::TMElement::giveCharacteristicVector(), oofem::TMSimpleMaterial::giveCharacteristicVector(), oofem::TR_SHELL01::giveCharacteristicVector(), oofem::TR_SHELL02::giveCharacteristicVector(), oofem::TransportElement::giveCharacteristicVector(), oofem::UPElement::giveCharacteristicVector(), oofem::CompoDamageMat::giveCharLengthForModes(), oofem::DofManager::giveCompleteUnknownVector(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::Lattice2d::giveCrossSectionCoordinates(), oofem::Lattice2d_mt::giveCrossSectionCoordinates(), oofem::Lattice2dBoundary::giveCrossSectionCoordinates(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::FEI3dTrLin::giveDerivativeEta(), oofem::FEI3dTrQuad::giveDerivativeEta(), oofem::FEI3dTrLin::giveDerivativeXi(), oofem::FEI3dTrQuad::giveDerivativeXi(), oofem::WeakPeriodicBoundaryCondition::giveEdgeNormal(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::LEPlic::giveElementMaterialMixture(), oofem::LevelSetPCS::giveElementMaterialMixture(), oofem::PrescribedMean::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::OOFEMTXTInputRecord::giveField(), oofem::XMLInputRecord::giveField(), oofem::TransportMaterial::giveFluxVector(), oofem::StructuralMaterial::giveFullSymVectorForm(), oofem::StructuralMaterial::giveFullVectorForm(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::Circle::giveGlobalCoordinates(), oofem::BondLink3d::giveGPCoordinates(), oofem::Lattice3d::giveGPCoordinates(), oofem::LatticeBeam3d::giveGPCoordinates(), oofem::LatticeLink3d::giveGPCoordinates(), oofem::Lattice2d::giveGpCoordinates(), oofem::Lattice2d_mt::giveGpCoordinates(), oofem::PolygonLine::giveInputRecord(), oofem::LayeredCrossSection::giveInterfaceXiCoords(), oofem::BaseMixedPressureElement::giveInternalForcesVector(), oofem::BondLink3d::giveInternalForcesVector(), oofem::BondLink3dBoundary::giveInternalForcesVector(), oofem::GradDpElement::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector(), oofem::HTSelement::giveInternalForcesVector(), oofem::IntElLine1PF::giveInternalForcesVector(), oofem::Lattice2dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeLink3d::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::LIBeam3dBoundary::giveInternalForcesVector(), oofem::LTRSpaceBoundary::giveInternalForcesVector(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::NodalSpringElement::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::QPlaneStress2dSlip::giveInternalForcesVector(), oofem::QTrPlaneStress2dSlip::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::Shell7BaseXFEM::giveInternalForcesVector(), oofem::SpringElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector(), oofem::Truss3dnl2::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector_d(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::CBSElement::giveInternalStateAtNode(), oofem::Element::giveInternalStateAtNode(), oofem::PFEMElement::giveInternalStateAtNode(), oofem::StructuralElement::giveInternalStateAtNode(), oofem::SUPGElement2::giveInternalStateAtNode(), oofem::SUPGElement::giveInternalStateAtNode(), oofem::TR1_2D_CBS::giveInternalStateAtNode(), oofem::TR1_2D_PFEM::giveInternalStateAtNode(), oofem::TransportElement::giveInternalStateAtNode(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::Beam2d::giveIPValue(), oofem::Beam3d::giveIPValue(), oofem::BondCEBMaterial::giveIPValue(), oofem::CCTPlate3d::giveIPValue(), oofem::CCTPlate::giveIPValue(), oofem::CebFipSlip90Material::giveIPValue(), oofem::CemhydMat::giveIPValue(), oofem::ConcreteDPM2::giveIPValue(), oofem::ConcreteDPM::giveIPValue(), oofem::ConcreteFCM::giveIPValue(), oofem::ConcreteFCMViscoElastic::giveIPValue(), oofem::CrossSection::giveIPValue(), oofem::DKTPlate3d::giveIPValue(), oofem::DKTPlate::giveIPValue(), oofem::DruckerPragerCutMat::giveIPValue(), oofem::DruckerPragerPlasticitySM::giveIPValue(), oofem::DustMaterial::giveIPValue(), oofem::Element::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::FluidDynamicMaterial::giveIPValue(), oofem::FRCFCM::giveIPValue(), oofem::FRCFCMNL::giveIPValue(), oofem::HeMoBazNajMaterial::giveIPValue(), oofem::HeMoKunzelMaterial::giveIPValue(), oofem::HeMoTKMaterial::giveIPValue(), oofem::HydratingConcreteMat::giveIPValue(), oofem::HydratingHeMoMaterial::giveIPValue(), oofem::HydratingIsoHeatMaterial::giveIPValue(), oofem::IDNLMaterial::giveIPValue(), oofem::IntMatIsoDamage::giveIPValue(), oofem::IsoInterfaceDamageMaterial::giveIPValue(), oofem::IsoInterfaceDamageMaterial_2::giveIPValue(), oofem::IsotropicDamageMaterial::giveIPValue(), oofem::IsotropicHeatTransferMaterial::giveIPValue(), oofem::IsotropicMoistureTransferMaterial::giveIPValue(), oofem::LatticeCrossSection::giveIPValue(), oofem::LatticeDamage::giveIPValue(), oofem::LatticePlasticityDamage::giveIPValue(), oofem::LatticeSlip::giveIPValue(), oofem::LinearElasticMaterial::giveIPValue(), oofem::LinkSlip::giveIPValue(), oofem::LinQuad3DPlaneStress::giveIPValue(), oofem::Material::giveIPValue(), oofem::MDM::giveIPValue(), oofem::MisesMat::giveIPValue(), oofem::MPSDamMaterial::giveIPValue(), oofem::MPSMaterial::giveIPValue(), oofem::QDKTPlate::giveIPValue(), oofem::Quad1Mindlin::giveIPValue(), oofem::Quad1MindlinShell3D::giveIPValue(), oofem::Quad1PlateSubSoil::giveIPValue(), oofem::RankineMat::giveIPValue(), oofem::RankineMatGrad::giveIPValue(), oofem::RankineMatNl::giveIPValue(), oofem::RCM2Material::giveIPValue(), oofem::RerShell::giveIPValue(), oofem::RheoChainMaterial::giveIPValue(), oofem::RVEStokesFlow::giveIPValue(), oofem::SimpleCrossSection::giveIPValue(), oofem::StructuralInterfaceCrossSection::giveIPValue(), oofem::StructuralInterfaceMaterial::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::tet21ghostsolid::giveIPValue(), oofem::TR1_2D_CBS::giveIPValue(), oofem::TR1_2D_SUPG2::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::TR_SHELL11::giveIPValue(), oofem::TrabBone3D::giveIPValue(), oofem::TrabBoneEmbed::giveIPValue(), oofem::TransportMaterial::giveIPValue(), oofem::TrPlanestressRotAllman3d::giveIPValue(), oofem::TrPlaneStrRot3d::giveIPValue(), oofem::Truss3d::giveIPValue(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::Shell7Base::giveMassFactorsAt(), oofem::LEPlic::giveMaterialMixtureAt(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::Shell7BaseXFEM::giveMaxCZDamages(), oofem::TR_SHELL11::giveNodeCoordinates(), oofem::TrPlaneStrRot3d::giveNodeCoordinates(), oofem::GradDpElement::giveNonlocalInternalForcesVector(), oofem::PolygonLine::giveNormal(), oofem::DofManager::givePrescribedUnknownVector(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::LatticeLinearElastic::giveRandomParameters(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::CompoDamageMat::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::FRCFCMNL::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::M1Material::giveRealStressVector_3d(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::B3Material::giveShrinkageStrainVector(), oofem::B3SolidMaterial::giveShrinkageStrainVector(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::J2Mat::giveStressBackVector(), oofem::J2MPlasticMaterial::giveStressBackVector(), oofem::J2plasticMaterial::giveStressBackVector(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::GaussIntegrationRule::giveTetCoordsAndWeights(), oofem::tet21ghostsolid::giveUnknownData(), oofem::ActiveDof::giveUnknowns(), oofem::ActiveDof::giveUnknowns(), oofem::Dof::giveUnknowns(), oofem::Dof::giveUnknowns(), oofem::SlaveDof::giveUnknowns(), oofem::SlaveDof::giveUnknowns(), oofem::DofManager::giveUnknownVector(), oofem::DofManager::giveUnknownVector(), oofem::LatticeDirichletCouplingNode::giveUnknownVector(), oofem::DofManager::giveUnknownVectorOfType(), oofem::LEPlic::giveUpdatedCoordinate(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::LatticeBeam3dBoundary::giveVTKCoordinates(), oofem::FEI1dHermite::global2local(), oofem::FEI1dLin::global2local(), oofem::FEI1dQuad::global2local(), oofem::FEI2dLineConst::global2local(), oofem::FEI2dLineHermite::global2local(), oofem::FEI2dLineLin::global2local(), oofem::FEI2dLineQuad::global2local(), oofem::FEI2dQuadLin::global2local(), oofem::FEI2dTrConst::global2local(), oofem::FEI2dTrLin::global2local(), oofem::FEI3dHexaConst::global2local(), oofem::FEI3dHexaLin::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::FEI3dTetLin::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dTrQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::FEInterpolation2d::global2local(), oofem::LSpace::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::LTRSpace::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::PlaneStress2d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::Quad1PlaneStrain::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::TrPlaneStrain::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::TrPlaneStress2d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::Truss1d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::DynCompRow::ILUPsolve(), oofem::DynCompRow::ILUPtrans_solve(), oofem::DynCompRow::ILUPYourself(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::HybridEI::interpGradLevelSet(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::MMAShapeFunctProjection::interpolateIntVarAt(), oofem::Quasicontinuum::intersectionTestSegmentTrianglePlucker3D(), oofem::FRCFCMNL::isStrengthExceeded(), oofem::FloatMatrix::jaco_(), oofem::StressStrainBaseVector::letStressStrainModeBe(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::BSplineInterpolation::local2global(), oofem::FEI1dHermite::local2global(), oofem::FEI1dLin::local2global(), oofem::FEI1dQuad::local2global(), oofem::FEI2dLineConst::local2global(), oofem::FEI2dLineHermite::local2global(), oofem::FEI2dLineLin::local2global(), oofem::FEI2dLineQuad::local2global(), oofem::FEI2dQuadConst::local2global(), oofem::FEI2dQuadQuad::local2global(), oofem::FEI2dTrConst::local2global(), oofem::FEI2dTrLin::local2global(), oofem::FEI2dTrQuad::local2global(), oofem::FEI3dQuadLin::local2global(), oofem::FEI3dTrLin::local2global(), oofem::FEI3dWedgeQuad::local2global(), oofem::NURBSInterpolation::local2global(), oofem::TSplineInterpolation::local2global(), oofem::ls2fit(), oofem::Tet1_3D_SUPG::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG_AXI::LS_PCS_computeVOFFractions(), oofem::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::VTKBaseExportModule::makeFullTensorForm(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::Shell7BaseXFEM::mapXi3FromLocalToShell(), oofem::Hexa21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::IntElLine1::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalAveragingRecoveryMI_computeNodalValue(), oofem::tet21ghostsolid::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tet21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tr21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_computeNValProduct(), oofem::QClinearStatic::nodeInFullSolvedDomainTest(), oofem::StressStrainBaseVector::operator=(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::LevelSetPCS::pcs_stage1(), oofem::MisesMat::performPlasticityReturn(), oofem::ConcreteDPM2::performRegularReturn(), plusProduct(), oofem::TransientTransportProblem::printOutputAt(), oofem::NonLinearDynamic::proceedStep(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::Lattice2dBoundary::recalculateCoordinates(), oofem::Lattice3dBoundary::recalculateCoordinates(), oofem::Lattice3dBoundaryTruss::recalculateCoordinates(), oofem::LatticeLink3dBoundary::recalculateCoordinates(), oofem::LIBeam3dBoundary::recalculateCoordinates(), oofem::LTRSpaceBoundary::recalculateCoordinates(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), restoreYourself(), oofem::PetscSparseMtrx::scatterG2L(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::Shell7Base::setupInitialEdgeSolutionVector(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), oofem::Parser::setVariableValue(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::CompCol_ILUPreconditioner::solve(), oofem::CylindricalALM::solve(), oofem::DiagPreconditioner::solve(), oofem::DynamicRelaxationSolver::solve(), oofem::GJacobi::solve(), oofem::InverseIteration::solve(), oofem::MKLPardisoSolver::solve(), oofem::NRSolver::solve(), oofem::PardisoProjectOrgSolver::solve(), oofem::PetscSolver::solve(), oofem::SLEPcSolver::solve(), oofem::SpoolesSolver::solve(), oofem::StaggeredSolver::solve(), oofem::SubspaceIteration::solve(), oofem::SuperLUSolver::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::CBS::solveYourselfAt(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::TestProblem::solveYourselfAt(), oofem::StressStrainBaseVector::StressStrainBaseVector(), oofem::FEI3dQuadLin::surfaceEvalBaseVectorsAt(), oofem::FEI3dTrLin::surfaceEvalBaseVectorsAt(), oofem::FEI3dHexaLin::surfaceEvalN(), oofem::FEI3dHexaQuad::surfaceEvalN(), oofem::FEI3dHexaTriQuad::surfaceEvalN(), oofem::FEI3dQuadLin::surfaceEvalN(), oofem::FEI3dTetLin::surfaceEvalN(), oofem::FEI3dTetQuad::surfaceEvalN(), oofem::FEI3dTrLin::surfaceEvalN(), oofem::FEI3dTrQuad::surfaceEvalN(), oofem::FEI3dWedgeLin::surfaceEvalN(), oofem::FEI3dWedgeQuad::surfaceEvalN(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dHexaLin::surfaceLocal2global(), oofem::FEI3dQuadLin::surfaceLocal2global(), oofem::FEI3dTetLin::surfaceLocal2global(), oofem::FEI3dTrLin::surfaceLocal2global(), oofem::CompCol::times(), oofem::DynCompCol::times(), oofem::DynCompRow::times(), oofem::PetscSparseMtrx::times(), oofem::Skyline::times(), oofem::SkylineUnsym::times(), oofem::SpoolesSparseMtrx::times(), oofem::SymCompCol::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::CompCol::timesT(), oofem::DynCompCol::timesT(), oofem::DynCompRow::timesT(), oofem::PetscSparseMtrx::timesT(), oofem::SkylineUnsym::timesT(), oofem::SpoolesSparseMtrx::timesT(), oofem::CompCol_ILUPreconditioner::trans_solve(), oofem::DiagPreconditioner::trans_solve(), oofem::Tr_Warp::transformCoordinates(), oofem::Line::transformIntoPolar(), oofem::MDM::transformStrainToPDC(), oofem::MDM::transformStressFromPDC(), oofem::StructuralEngngModel::updateInternalRHS(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::NodalRecoveryModel::updateRegionRecoveredValues(), oofem::ScalarAdvectionRhsAssembler::vectorFromElement(), oofem::SUPGInternalForceAssembler::vectorFromElement(), oofem::TMResidualAssembler::vectorFromElement(), oofem::UPResidualAssembler::vectorFromElement(), oofem::VTKXMLExportModule::writeCellVars(), oofem::VTKXMLLatticeExportModule::writeCellVarsCross(), oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), oofem::UniformGridField::xyz2ijk(), oofem::TR_SHELL01::ZZErrorEstimatorI_computeLocalStress(), oofem::TR_SHELL02::ZZErrorEstimatorI_computeLocalStress(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().

◆ resizeWithValues()

void oofem::FloatArray::resizeWithValues ( Index s,
std::size_t allocChunk = 0 )

Checks size of receiver towards requested bounds. If dimension mismatch, size is adjusted accordingly. Old values are copied over and new space is zeroed.

Parameters
sNew size.
allocChunkAdditional space to allocate.

Definition at line 103 of file floatarray.C.

References _DBG, OOFEM_FATAL, and values.

Referenced by addSubVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::LTRSpaceBoundary::computeDeformationGradientVector(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::RVEStokesFlow::computeFlux3D(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::RigidArmNode::computeMasterContribution(), oofem::Line::computeNumberOfIntersectionPoints(), oofem::PrescribedDispSlipBCNeumannRC::computeReinfStress(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::PolygonLine::computeTangentialSignDist(), copySubVector(), oofem::PrescribedGradientBCWeak::createTractionMesh(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7BaseXFEM::EvaluateEnrFuncInDofMan(), oofem::VTKXMLExportModule::exportIntVarsInGpAs(), oofem::VTKBaseExportModule::getCellVariableFromIS(), oofem::VTKBaseExportModule::getNodalVariableFromIS(), oofem::VTKXMLXFemExportModule::getNodalVariableFromXFEMST(), oofem::Element::giveGlobalIPValue(), oofem::LIBeam3dBoundary::giveIPValue(), oofem::LTRSpaceBoundary::giveIPValue(), oofem::TransportMaterial::giveIPValue(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::RCM2Material::giveRealStressVector(), oofem::DofManager::giveUnknownVector(), oofem::DofManager::giveUnknownVector(), oofem::DynCompRow::ILUPYourself(), oofem::GeometryBasedEI::updateLevelSets(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), and oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay().

◆ restoreYourself()

◆ rotatedWith()

void oofem::FloatArray::rotatedWith ( FloatMatrix & r,
char mode )

Returns the receiver a rotated according the change-of-base matrix r.

Parameters
rRotation matrix.
modeIf mode == 't' the method performs the operation \( a = t^{\mathrm{T}} \cdot r \), else if mode = 'n' then the method performs the operation \( a = t \cdot r \).
Returns
modified receiver.

Definition at line 814 of file floatarray.C.

References beProductOf(), beTProductOf(), FloatArray(), FloatMatrix, and OOFEM_ERROR.

Referenced by oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::TransverseReinfConstraint::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::EngngModel::assembleVectorFromElements(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TR_SHELL11::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::Node::computeLoadVector(), oofem::BaseMixedPressureElement::computeLocForceLoadVector(), oofem::RigidArmNode::computeMasterContribution(), oofem::StructuralElement::computePointLoadVectorAt(), oofem::Lattice2dBoundary::computeStrainVector(), oofem::Lattice3dBoundary::computeStrainVector(), oofem::Lattice3dBoundaryTruss::computeStrainVector(), oofem::LatticeLink3dBoundary::computeStrainVector(), oofem::StructuralInterfaceElement::computeTraction(), oofem::StructuralInterfaceElementPhF::computeTraction(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOfPrescribed(), oofem::Element::computeVectorOfPrescribed(), oofem::Node::drawYourself(), oofem::BoundaryFluxFunctor::evaluate(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::Lattice2dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::DofManager::givePrescribedUnknownVector(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::FRCFCMNL::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::DofManager::giveUnknownVector(), oofem::DofManager::giveUnknownVector(), oofem::LatticeDirichletCouplingNode::giveUnknownVector(), oofem::IsotropicDamageMaterial1::initDamaged(), and oofem::Shell7BaseXFEM::recoverShearStress().

◆ size()

◆ storeYourself()

contextIOResultType oofem::FloatArray::storeYourself ( DataStream & stream) const

◆ subtract()

void oofem::FloatArray::subtract ( const FloatArray & src)

Subtracts array src to receiver. If the receiver's size is zero, it adjusts its size to size of src array. If recever's size is nonzero and different from src array size an error is generated.

Definition at line 320 of file floatarray.C.

References _resize_internal(), FloatArray(), giveSize(), isEmpty(), OOFEM_ERROR, and size().

Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::ContactBoundaryCondition::assembleExtrapolatedForces(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::CylindricalALM::checkConvergence(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::LTRSpaceBoundary::computeDeformationGradientVector(), oofem::NLStructuralElement::computeDeformationGradientVector(), oofem::tet21ghostsolid::computeDeformationGradientVectorFromDispl(), oofem::TransportGradientNeumann::computeEta(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::LinearEdgeLoad::computeNArray(), oofem::StructuralEngngModel::computeReaction(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStrainVector(), oofem::Lattice3dBoundaryTruss::computeStrainVector(), oofem::LatticeLink3dBoundary::computeStrainVector(), oofem::LIBeam3dBoundary::computeStrainVector(), oofem::LTRSpaceBoundary::computeStrainVector(), oofem::StructuralElement::computeStrainVector(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::UsrDefBoundaryLoad::computeValueAt(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::RotatingBoundary::give(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::MFrontUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::UnstructuredGridField::Cell::giveBoundingBox(), oofem::TMElement::giveCharacteristicVector(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::Beam2d::giveEndForcesVector(), oofem::Beam3d::giveEndForcesVector(), oofem::BondLink3d::giveInternalForcesVector(), oofem::BondLink3dBoundary::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::Lattice2dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeBeam3d::giveInternalForcesVector(), oofem::LatticeBeam3dBoundary::giveInternalForcesVector(), oofem::LatticeLink3d::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::TrPlaneStress2dXFEM::giveInternalForcesVector(), oofem::Truss3dnl2::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_u(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::TR_SHELL11::giveLocalCoordinates(), oofem::TrPlaneStrRot3d::giveLocalCoordinates(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::ConcreteFCMViscoElastic::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::Shell7Base::giveShellExportData(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::B3Material::giveShrinkageStrainVector(), oofem::B3SolidMaterial::giveShrinkageStrainVector(), oofem::SteelRelaxMat::giveStressDependentPartOfStrainVector(), oofem::StructuralMaterial::giveStressDependentPartOfStrainVector(), oofem::FEI3dHexaConst::global2local(), oofem::FEI3dHexaLin::global2local(), oofem::PrimaryField::initialize(), oofem::operator-=(), oofem::MisesMat::performPlasticityReturn(), oofem::RankineMat::performPlasticityReturn(), oofem::MisesMat::performPlasticityReturn_PlaneStress(), oofem::TransientTransportProblem::printOutputAt(), oofem::FETISolver::projection(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::CylindricalALM::solve(), oofem::FETISolver::solve(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::Pdelta::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::TR_SHELL01::SpatialLocalizerI_giveBBox(), oofem::TR_SHELL02::SpatialLocalizerI_giveBBox(), oofem::StructuralElementEvaluator::updateInternalState(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeDeformationGradientVector(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

◆ sum()

◆ times()

void oofem::FloatArray::times ( double s)

Multiplies receiver with scalar.

Parameters
sScalar to multiply by.

Definition at line 834 of file floatarray.C.

Referenced by oofem::Integral::assemble_rhs(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::HOMExportModule::average(), oofem::Subdivision::RS_Tetra::bisect(), oofem::Subdivision::RS_Triangle::bisect(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::EnrichmentItem::calcPolarCoord(), oofem::CylindricalALM::checkConvergence(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::Beam2d::computeBodyLoadVectorAt(), oofem::Beam3d::computeBodyLoadVectorAt(), oofem::LIBeam2d::computeBodyLoadVectorAt(), oofem::LIBeam2dNL::computeBodyLoadVectorAt(), oofem::LIBeam3d2::computeBodyLoadVectorAt(), oofem::LIBeam3d::computeBodyLoadVectorAt(), oofem::LIBeam3dNL2::computeBodyLoadVectorAt(), oofem::LIBeam3dNL::computeBodyLoadVectorAt(), oofem::TMElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::TMElement::computeBoundarySurfaceLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::PhaseFieldElement::computeBStress_u(), oofem::Eurocode2CreepMaterial::computeCharCoefficients(), oofem::Load::computeComponentArrayAt(), oofem::ContactPair::computeContactPointDisplacement(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::EnrichmentFront::computeCrackTangent(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::ActiveDof::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::StaticStructural::computeExternalLoadReactionContribution(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGenStrainShell7::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::PrescribedGradientBCWeak::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::Tr_Warp::computeFirstMomentOfArea(), oofem::IntElPoint::computeGlobalCoordinates(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::Truss3dnl::computeInitialStressStiffness(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::Lattice3d_mt::computeInternalSourceRhsVectorAt(), oofem::VTKBaseExportModule::computeIPAverage(), oofem::XfemStructuralElementInterface::computeIPAverageInTriangle(), oofem::LatticeNeumannCouplingNode::computeLoadCouplingContribution(), oofem::MDM::computeLocalDamageTensor(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::WeakPeriodicBoundaryCondition::computeOrthogonalBasis(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::Shell7Base::computePressureForceAt(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::computeReinfStress(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::PrescribedDispSlipBCDirichletRC::computeStress(), oofem::PrescribedDispSlipBCNeumannRC::computeStress(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::LIBeam3dNL::computeTempCurv(), oofem::StructuralPenaltyContactBoundaryCondition::computeTractions(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::PrescribedDispSlipBCNeumannRC::computeTransferStress(), oofem::BoundaryLoad::computeValueAt(), oofem::ConstantPressureLoad::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::GravityPressure::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::PointLoad::computeValueAt(), oofem::NeumannMomentLoad::computeXbar(), oofem::TransportGradientDirichlet::computeXi(), oofem::CrackExportModule::doOutput(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::MITC4Shell::drawScalar(), oofem::TR_SHELL01::drawScalar(), oofem::TR_SHELL02::drawScalar(), oofem::FEI2dLineLin::edgeEvaldNds(), oofem::FEI2dLineQuad::edgeEvaldNds(), oofem::FEI2dTrQuad::edgeEvaldNds(), oofem::Shell7BaseXFEM::edgeGiveUpdatedSolutionVector(), oofem::NURBSInterpolation::evalN(), oofem::TSplineInterpolation::evalN(), oofem::VTKExportModule::exportCellVars(), oofem::PrescribedDispSlipBCDirichletRC::give(), oofem::PrescribedGenStrainShell7::give(), oofem::PrescribedGradient::give(), oofem::IsotropicDamageMaterial::give1dStressStiffMtrx(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::MFrontUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::PolygonLine::giveBoundingSphere(), oofem::TMElement::giveCharacteristicVector(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::MPSMaterial::giveEigenStrainVector(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::PrescribedMean::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::IsotropicGradientDamageMaterial::giveGradientDamageStiffnessMatrix_ud(), oofem::BondLink3dBoundary::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::Lattice2dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeLink3d::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector_d(), oofem::BaseMixedPressureElement::giveInternalForcesVector_p(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::TwoFluidMaterial::giveIPValue(), oofem::IsotropicGradientDamageMaterial::giveNonlocalInternalForces_B_factor(), oofem::LargeStrainMasterMaterialGrad::giveNonlocalInternalForces_B_factor(), oofem::MisesMatGrad::giveNonlocalInternalForces_B_factor(), oofem::RankineMatGrad::giveNonlocalInternalForces_B_factor(), oofem::TrabBoneGrad3D::giveNonlocalInternalForces_B_factor(), oofem::IsotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPlasticMaterial2::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::GiveStressCorrectionBackToYieldSurface(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::PrescribedGradientBCWeak::giveTraction(), oofem::FEIElementDeformedGeometryWrapper::giveVertexCoordinates(), oofem::Homogenize::herveZaoui(), oofem::MPElement::integrateEdgeTerm_c(), oofem::MPElement::integrateSurfaceTerm_c(), oofem::MPElement::integrateTerm_c(), oofem::NURBSInterpolation::local2global(), oofem::TSplineInterpolation::local2global(), oofem::Q9PlaneStress2d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QPlaneStress2d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalAveragingRecoveryMI_computeNodalValue(), normalize_giveNorm(), oofem::operator*=(), oofem::operator/=(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputGradient(), oofem::MisesMat::performPlasticityReturn(), oofem::MisesMat::performPlasticityReturn_PlaneStress(), oofem::PLMaterialForce::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::Subdivision::smoothMesh(), oofem::CylindricalALM::solve(), oofem::LineSearchNM::solve(), oofem::NRSolver::solve(), oofem::CBS::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::XfemStructureManager::splitCracks(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::FEI3dQuadLin::surfaceEvalNormal(), oofem::FEI3dTrLin::surfaceEvalNormal(), oofem::FEI3dTrQuad::surfaceEvalNormal(), oofem::Subdivision::unpackSharedIrregulars(), oofem::TransientTransportProblem::updateComponent(), oofem::TransientTransportProblem::updateInternalRHS(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::Tet1_3D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG_AXI::updateStabilizationCoeffs(), oofem::PFEMCorrectionRhsAssembler::vectorFromElement(), oofem::UPResidualAssembler::vectorFromElement(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), and oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay().

◆ zero()

void oofem::FloatArray::zero ( )

Zeroes all coefficients of receiver.

Definition at line 683 of file floatarray.C.

References begin(), and end().

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMALeastSquareProjection::__mapVariable(), oofem::Quasicontinuum::applyApproach3(), oofem::NonStationaryTransportProblem::applyIC(), oofem::PFEM::applyIC(), oofem::SUPG::applyIC(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::ContactBoundaryCondition::assembleExtrapolatedForces(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::NonLinearStatic::assembleIncrementalReferenceLoadVectors(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::DIIDynamic::assembleLoadVector(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::EngngModel::assembleVector(), oofem::HOMExportModule::average(), oofem::CylindricalALM::checkConvergence(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MC(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubVectorAt(), oofem::TransportElement::computeBCVectorAt(), oofem::LSpaceBB::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::TR1_2D_PFEM::computeBodyLoadVectorAt(), oofem::TR_SHELL01::computeBodyLoadVectorAt(), oofem::TR_SHELL11::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::TMElement::computeBoundaryEdgeLoadVector(), oofem::UPElement::computeBoundaryEdgeLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::TMElement::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::UPElement::computeBoundarySurfaceLoadVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::Load::computeComponentArrayAt(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::TR1_2D_CBS::computeCorrectionRhs(), oofem::IntElSurfQuad1::computeCovarBaseVectorsAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::MazarsMaterial::computeDamageParam(), oofem::TR1_2D_CBS::computeDensityRhsPressureTerms(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::TR1_2D_PFEM::computeDeviatoricStressDivergence(), oofem::TR1_2D_CBS::computeDiagonalMassMtrx(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::RheoChainMaterial::computeDiscreteRelaxationFunction(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::FRCFCMNL::computeElementCentroid(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::StaticStructural::computeExternalLoadReactionContribution(), oofem::StructuralEngngModel::computeExternalLoadReactionContribution(), oofem::Hexa21Stokes::computeField(), oofem::Line2BoundaryElement::computeField(), oofem::PrescribedGenStrainShell7::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::Tet1BubbleStokes::computeField(), oofem::Tr1BubbleStokes::computeField(), oofem::Tr21Stokes::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::Lattice3d_mt::computeFlow(), oofem::TransportElement::computeFlow(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::IntElSurfQuad1::computeGlobalCoordinates(), oofem::IntElSurfTr1::computeGlobalCoordinates(), oofem::InterfaceElement3dTrLin::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::Truss2d::computeGlobalCoordinates(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::StructuralPenaltyContactBoundaryCondition::computeInternalForcesFromContact(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::TransportElement::computeInternalSourceRhsVectorAt(), oofem::TR21_2D_SUPG::computeIntersection(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::DruckerPragerCutMat::computeKGradientVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::NlDEIDynamic::computeLoadVector(), oofem::PFEMElement::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::TMElement::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::CCTPlate::computeLocalCoordinates(), oofem::DKTPlate::computeLocalCoordinates(), oofem::QDKTPlate::computeLocalCoordinates(), oofem::RerShell::computeLocalCoordinates(), oofem::BaseMixedPressureElement::computeLocForceLoadVector(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::LinearEdgeLoad::computeNArray(), oofem::XfemElementInterface::computeNCohesive(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::TR1_2D_CBS::computeNumberOfNodalPrescribedTractionPressureContributions(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::B3SolidMaterial::computePointShrinkageStrainVector(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computePressureForceAt(), oofem::StrainVector::computePrincipalValDir(), oofem::StressVector::computePrincipalValDir(), oofem::StructuralMaterial::computePrincipalValDir(), oofem::StrainVector::computePrincipalValues(), oofem::StressVector::computePrincipalValues(), oofem::StructuralMaterial::computePrincipalValues(), oofem::HTSelement::computePsVectorAt(), oofem::HTSelement::computePuVectorAt(), oofem::StructuralEngngModel::computeReaction(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::Shell7Base::computeSectionalForces(), oofem::B3Material::computeShrinkageStrainVector(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::BondLink3d::computeStiffnessMatrix(), oofem::BondLink3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3d::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::DruckerPragerCutMat::computeStrainHardeningVarsIncrement(), oofem::Masonry02::computeStrainHardeningVarsIncrement(), oofem::StructuralElement::computeStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::PrescribedDispSlipBCDirichletRC::computeStress(), oofem::J2Mat::computeStressGradientVector(), oofem::J2MPlasticMaterial::computeStressGradientVector(), oofem::Masonry02::computeStressGradientVector(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::FE2FluidMaterial::computeTangents3D(), oofem::B3SolidMaterial::computeTotalAverageShrinkageStrainVector(), oofem::Shell7Base::computeTractionForce(), oofem::StructuralPenaltyContactBoundaryCondition::computeTractions(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::LatticeDirichletCouplingNode::computeUnknownCouplingContribution(), oofem::ConstantEdgeLoad::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::Load::computeValues(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::SuperLUSolver::convertRhs(), oofem::StressStrainBaseVector::convertToFullForm(), oofem::StructuralFE2MaterialStatus::copyStateVariables(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::LEPlic::doCellDLS(), oofem::Lattice2dBoundary::drawRawCrossSections(), oofem::Lattice2dBoundary::drawSpecial(), oofem::FEI2dLineConst::edgeEvaldNds(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::tet21ghostsolid::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::Tet21Stokes::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::BSplineInterpolation::evaldNdx(), oofem::NURBSInterpolation::evaldNdx(), oofem::FEI1dHermite::evalN(), oofem::FEI1dQuad::evalN(), oofem::FEI2dLineHermite::evalN(), oofem::BDalphaPiTerm::evaluate(), oofem::BTdSigmadT::evaluate(), oofem::UniformGridField::evaluateAt(), oofem::DiscontinuousFunction::evaluateEnrFuncDerivAt(), oofem::HeavisideFunction::evaluateEnrFuncDerivAt(), oofem::RampFunction::evaluateEnrFuncDerivAt(), oofem::VTKExportModule::exportIntVarAs(), oofem::VTKXMLLatticeExportModule::exportIntVars(), oofem::VTKXMLPeriodicExportModule::exportIntVars(), oofem::VTKExportModule::exportPrimVarAs(), oofem::SkylineUnsym::factorized(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStress2d::giveCharacteristicSize(), oofem::PFEMElement::giveCharacteristicVector(), oofem::SUPGElement2::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::TMElement::giveCharacteristicVector(), oofem::TMSimpleMaterial::giveCharacteristicVector(), oofem::TR_SHELL01::giveCharacteristicVector(), oofem::TR_SHELL02::giveCharacteristicVector(), oofem::UPElement::giveCharacteristicVector(), oofem::Lattice2d::giveCrossSectionCoordinates(), oofem::Lattice2dBoundary::giveCrossSectionCoordinates(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::StructuralMaterial::giveFullSymVectorForm(), oofem::StructuralMaterial::giveFullVectorForm(), oofem::BaseMixedPressureElement::giveInternalForcesVector(), oofem::BondLink3d::giveInternalForcesVector(), oofem::BondLink3dBoundary::giveInternalForcesVector(), oofem::GradDpElement::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector(), oofem::IntElLine1PF::giveInternalForcesVector(), oofem::Lattice2dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeBeam3d::giveInternalForcesVector(), oofem::LatticeBeam3dBoundary::giveInternalForcesVector(), oofem::LatticeLink3d::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::LIBeam3dBoundary::giveInternalForcesVector(), oofem::LTRSpaceBoundary::giveInternalForcesVector(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::Shell7BaseXFEM::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector(), oofem::Truss3dnl2::giveInternalForcesVector(), oofem::Truss3dnl::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::ConcreteDPM2::giveIPValue(), oofem::ConcreteDPM::giveIPValue(), oofem::ConcreteFCM::giveIPValue(), oofem::ConcreteFCMViscoElastic::giveIPValue(), oofem::DruckerPragerCutMat::giveIPValue(), oofem::DruckerPragerPlasticitySM::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::FE2FluidMaterial::giveIPValue(), oofem::IDNLMaterial::giveIPValue(), oofem::IntMatIsoDamage::giveIPValue(), oofem::IsoInterfaceDamageMaterial::giveIPValue(), oofem::IsoInterfaceDamageMaterial_2::giveIPValue(), oofem::IsotropicDamageMaterial::giveIPValue(), oofem::LatticeDamage::giveIPValue(), oofem::LatticePlasticityDamage::giveIPValue(), oofem::LatticeSlip::giveIPValue(), oofem::LinearElasticMaterial::giveIPValue(), oofem::LinkSlip::giveIPValue(), oofem::MDM::giveIPValue(), oofem::MPSDamMaterial::giveIPValue(), oofem::MPSMaterial::giveIPValue(), oofem::RankineMat::giveIPValue(), oofem::RCM2Material::giveIPValue(), oofem::RheoChainMaterial::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::TransportMaterial::giveIPValue(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::LatticeLinearElastic::giveRandomParameters(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FCMMaterial::giveRealStressVector(), oofem::FRCFCMNL::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::M1Material::giveRealStressVector_3d(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::B3Material::giveShrinkageStrainVector(), oofem::B3SolidMaterial::giveShrinkageStrainVector(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::tet21ghostsolid::giveUnknownData(), oofem::DofManager::giveUnknownVectorOfType(), oofem::Node::giveUpdatedCoordinate(), oofem::LatticeBeam3dBoundary::giveVTKCoordinates(), oofem::Shell7Base::giveZ2integratedPolynomial2GradientForStressRecAt(), oofem::Shell7Base::giveZintegratedPolynomialGradientForStressRecAt(), oofem::FEI2dQuadLin::global2local(), oofem::FEI3dHexaConst::global2local(), oofem::FEI3dHexaLin::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::FEInterpolation2d::global2local(), oofem::Homogenize::herveZaoui(), oofem::CompCol_ICPreconditioner::ICSolve(), oofem::DynCompRow::ILUPsolve(), oofem::MazarsMaterial::initDamaged(), oofem::FCMMaterial::initializeCrack(), oofem::HybridEI::interpGradLevelSet(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::FRCFCMNL::isStrengthExceeded(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::BSplineInterpolation::local2global(), oofem::FEI2dLineConst::local2global(), oofem::FEI2dLineHermite::local2global(), oofem::FEI2dLineLin::local2global(), oofem::FEI2dQuadQuad::local2global(), oofem::FEI2dTrLin::local2global(), oofem::FEI2dTrQuad::local2global(), oofem::FEI3dWedgeQuad::local2global(), oofem::NURBSInterpolation::local2global(), oofem::TSplineInterpolation::local2global(), oofem::ls2fit(), oofem::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::VTKBaseExportModule::makeFullTensorForm(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7Base::NodalRecoveryMI_computeNValProduct(), oofem::LevelSetPCS::pcs_stage1(), oofem::TransientTransportProblem::printOutputAt(), oofem::NonLinearDynamic::proceedStep(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::Lattice2dBoundary::recalculateCoordinates(), oofem::Lattice3dBoundary::recalculateCoordinates(), oofem::Lattice3dBoundaryTruss::recalculateCoordinates(), oofem::LatticeLink3dBoundary::recalculateCoordinates(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::Shell7Base::setupInitialEdgeSolutionVector(), oofem::VTKXMLLatticeExportModule::setupVTKPiece(), oofem::VTKXMLPeriodicExportModule::setupVTKPiece(), oofem::Subdivision::smoothMesh(), oofem::CompCol_ILUPreconditioner::solve(), oofem::CylindricalALM::solve(), oofem::DynamicRelaxationSolver::solve(), oofem::NRSolver::solve(), oofem::StaggeredSolver::solve(), oofem::SubspaceIteration::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::CBS::solveYourselfAt(), oofem::LinearStatic::solveYourselfAt(), oofem::MPMProblem::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::Pdelta::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::TransientTransportProblem::solveYourselfAt(), oofem::StressStrainBaseVector::StressStrainBaseVector(), oofem::CompCol::times(), oofem::DynCompCol::times(), oofem::DynCompRow::times(), oofem::Skyline::times(), oofem::SkylineUnsym::times(), oofem::SpoolesSparseMtrx::times(), oofem::SymCompCol::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::CompCol::timesT(), oofem::DynCompCol::timesT(), oofem::DynCompRow::timesT(), oofem::SkylineUnsym::timesT(), oofem::SpoolesSparseMtrx::timesT(), oofem::StationaryMPMSProblem::updateComponent(), oofem::MPMProblem::updateInternalRHS(), oofem::StaticStructural::updateInternalRHS(), oofem::StationaryTransportProblem::updateInternalRHS(), oofem::StokesFlow::updateInternalRHS(), oofem::StructuralEngngModel::updateInternalRHS(), oofem::SUPG::updateInternalRHS(), oofem::TransientTransportProblem::updateInternalRHS(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::ScalarAdvectionRhsAssembler::vectorFromElement(), oofem::SUPGInternalForceAssembler::vectorFromElement(), oofem::TMResidualAssembler::vectorFromElement(), oofem::UPResidualAssembler::vectorFromElement(), oofem::VTKXMLExportModule::writeVTKPieceProlog(), oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), and oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay().

◆ FloatMatrix

◆ operator<<

std::ostream & operator<< ( std ::ostream & out,
const FloatArray & x )
friend

Definition at line 1146 of file floatarray.C.

References FloatArray(), and giveSize().

Member Data Documentation

◆ Dim

int oofem::FloatArray::Dim = 1
staticconstexpr

Definition at line 113 of file floatarray.h.

◆ values


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

This page is part of the OOFEM-3.0 documentation. Copyright Copyright (C) 1994-2025 Borek Patzak Bořek Patzák
Project e-mail: oofem@fsv.cvut.cz
Generated at for OOFEM by doxygen 1.15.0 written by Dimitri van Heesch, © 1997-2011