OOFEM  2.4
OOFEM.org - Object Oriented Finite Element Solver
oofem::FloatArray Class Reference

Class representing vector of real numbers. More...

#include <floatarray.h>

+ Inheritance diagram for oofem::FloatArray:

Public Member Functions

 FloatArray (int n=0)
 Constructor for sized array. Data is zeroed. More...
 
 FloatArray (double)=delete
 Disallow double parameter, which can otherwise give unexpected results. More...
 
 FloatArray (const FloatArray &src)
 Copy constructor. Creates the array from another array. More...
 
 FloatArray (FloatArray &&src)
 Move constructor. Creates the array from another array. More...
 
 FloatArray (std::initializer_list< double >list)
 Initializer list constructor. More...
 
virtual ~FloatArray ()
 Destructor. More...
 
FloatArrayoperator= (const FloatArray &src)
 Assignment operator. More...
 
FloatArrayoperator= (FloatArray &&src)
 Move operator. More...
 
FloatArrayoperator= (std::initializer_list< double >list)
 Assignment operator. More...
 
void push_back (const double &iVal)
 Add one element. More...
 
bool isFinite () const
 Returns true if no element is NAN or infinite. More...
 
double & at (int i)
 Coefficient access function. More...
 
double at (int i) const
 Coefficient access function. More...
 
double & operator() (int i)
 Coefficient access function. More...
 
double & operator[] (int i)
 
const double & operator() (int i) const
 Coefficient access function. More...
 
const double & operator[] (int i) const
 
void checkBounds (int i) const
 Checks size of receiver towards requested bounds. More...
 
void checkSizeTowards (const IntArray &loc)
 Checks size of receiver towards values stored in loc array. More...
 
void reserve (int s)
 Allocates enough size to fit s, and clears the array. More...
 
void resizeWithValues (int s, int allocChunk=0)
 Checks size of receiver towards requested bounds. More...
 
void resize (int s)
 Resizes receiver towards requested size. More...
 
void clear ()
 Clears receiver (zero size). More...
 
void hardResize (int s)
 Resizes the size of the receiver to requested bounds. More...
 
bool containsOnlyZeroes () const
 Returns nonzero if all coefficients of the receiver are 0, else returns zero. More...
 
int giveSize () const
 Returns the size of receiver. More...
 
bool isNotEmpty () const
 Returns true if receiver is not empty. More...
 
bool isEmpty () const
 Returns true if receiver is empty. More...
 
void negated ()
 Switches the sign of every coefficient of receiver. More...
 
virtual void printYourself () const
 Print receiver on stdout. More...
 
virtual void printYourself (const std::string &name) const
 Print receiver on stdout with custom name. More...
 
virtual void printYourselfToFile (const std::string filename, const bool showDimensions=true) const
 Print receiver to file. More...
 
virtual void pY () const
 Print receiver on stdout with high accuracy. More...
 
void zero ()
 Zeroes all coefficients of receiver. More...
 
void append (const FloatArray &a)
 Appends array to reciever. More...
 
void append (double a)
 Appends value to reciever. More...
 
void beProductOf (const FloatMatrix &aMatrix, const FloatArray &anArray)
 Receiver becomes the result of the product of aMatrix and anArray. More...
 
void beTProductOf (const FloatMatrix &aMatrix, const FloatArray &anArray)
 Receiver becomes the result of the product of aMatrix^T and anArray. More...
 
void 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. More...
 
void beScaled (double s, const FloatArray &b)
 Sets receiver to be $ a = s b $. More...
 
void add (const FloatArray &src)
 Adds array src to receiver. More...
 
void add (double factor, const FloatArray &b)
 Adds array times factor to receiver. More...
 
void plusProduct (const FloatMatrix &b, const FloatArray &s, double dV)
 Adds the product $ b^T . s dV $. More...
 
void add (double offset)
 Adds scalar to receiver. More...
 
void subtract (const FloatArray &src)
 Subtracts array src to receiver. More...
 
void times (double s)
 Multiplies receiver with scalar. More...
 
void beMaxOf (const FloatArray &a, const FloatArray &b)
 Sets receiver to maximum of a or b's respective elements. More...
 
void beMinOf (const FloatArray &a, const FloatArray &b)
 Sets receiver to be minimum of a or b's respective elements. More...
 
void beDifferenceOf (const FloatArray &a, const FloatArray &b)
 Sets receiver to be a - b. More...
 
void beDifferenceOf (const FloatArray &a, const FloatArray &b, int n)
 Sets receiver to be a - b, using only the first n entries. More...
 
void beSubArrayOf (const FloatArray &src, const IntArray &indx)
 Extract sub vector form src array and stores the result into receiver. More...
 
void addSubVector (const FloatArray &src, int si)
 Adds the given vector as sub-vector to receiver. More...
 
void 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. More...
 
void assembleSquared (const FloatArray &fe, const IntArray &loc)
 Assembles the array fe with each component squared. More...
 
void copySubVector (const FloatArray &src, int si)
 Copy the given vector as sub-vector to receiver. More...
 
double distance (const FloatArray &x) const
 Computes the distance between position represented by receiver and position given as parameter. More...
 
double distance (const FloatArray *x) const
 
double 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. More...
 
double distance_square (const FloatArray &iP1, const FloatArray &iP2, double &oXi, double &oXiUnbounded) const
 
double distance_square (const FloatArray &x) const
 Computes the square of distance between position represented by receiver and position given as parameter. More...
 
int giveIndexMinElem (void)
 Returns index (between 1 and Size) of minimum element in the array. More...
 
int giveIndexMaxElem (void)
 Returns index (between 1 and Size) of maximum element in the array. More...
 
double dotProduct (const FloatArray &x) const
 Computes the dot product (or inner product) of receiver and argument. More...
 
double dotProduct (const FloatArray &x, int size) const
 Computes the dot product (or inner product) of receiver and argument. More...
 
double normalize ()
 Normalizes receiver. More...
 
double computeNorm () const
 Computes the norm (or length) of the vector. More...
 
double computeSquaredNorm () const
 Computes the square of the norm. More...
 
double sum () const
 Computes the sum of receiver values. More...
 
double product () const
 Computes the product of receiver values. More...
 
void rotatedWith (FloatMatrix &r, char mode)
 Returns the receiver a rotated according the change-of-base matrix r. More...
 
const double * givePointer () const
 Gives the pointer to the raw data, breaking encapsulation. More...
 
double * givePointer ()
 
void beVectorForm (const FloatMatrix &aMatrix)
 Reciever will be a vector with 9 components formed from a 3x3 matrix. More...
 
void beSymVectorForm (const FloatMatrix &aMatrix)
 Reciever will be a vector with 6 components formed from a 3x3 matrix. More...
 
void beSymVectorFormOfStrain (const FloatMatrix &aMatrix)
 
void changeComponentOrder ()
 Swaps the fourth and sixth index in the array. More...
 
void power (const double exponent)
 Raise each element to its power. More...
 
void beColumnOf (const FloatMatrix &mat, int col)
 Reciever will be set to a given column in a matrix. More...
 
contextIOResultType storeYourself (DataStream &stream) const
 
contextIOResultType restoreYourself (DataStream &stream)
 
int givePackSize (DataStream &buff) const
 
Iterator for for-each loops:
std::vector< double >::iterator begin ()
 
std::vector< double >::iterator end ()
 
std::vector< double >::const_iterator begin () const
 
std::vector< double >::const_iterator end () const
 
IML compatibility
FloatArrayoperator= (const double &)
 Assignment of scalar to all components of receiver. More...
 

Protected Attributes

std::vector< double > values
 Stored values. More...
 

Friends

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

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 82 of file floatarray.h.

Constructor & Destructor Documentation

oofem::FloatArray::FloatArray ( int  n = 0)
inline

Constructor for sized array. Data is zeroed.

Definition at line 98 of file floatarray.h.

oofem::FloatArray::FloatArray ( double  )
delete

Disallow double parameter, which can otherwise give unexpected results.

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

Copy constructor. Creates the array from another array.

Definition at line 102 of file floatarray.h.

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

Move constructor. Creates the array from another array.

Definition at line 104 of file floatarray.h.

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

Initializer list constructor.

Definition at line 106 of file floatarray.h.

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

Destructor.

Definition at line 108 of file floatarray.h.

Member Function Documentation

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 156 of file floatarray.C.

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

Referenced by oofem::ParticleTopologyDescription::addLineSegment(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::FloatMatrix::beLocalCoordSys(), oofem::Subdivision::RS_Triangle::bisect(), oofem::Subdivision::RS_Tetra::bisect(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::ParticleTopologyDescription::calculateShortestDistance(), oofem::CylindricalALM::checkConvergence(), oofem::ConcreteDPM2::checkForUnAndReloading(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::SolidShell::computeAlpha(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubVectorAt(), oofem::TransportElement::computeBodyBCSubVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::ConcreteDPM::computeDCosThetaDStress(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormCompression(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::TwoFluidMaterial::computeDeviatoricStressVector(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::Hexa21Stokes::computeExternalForcesVector(), oofem::Tet21Stokes::computeExternalForcesVector(), oofem::Tr21Stokes::computeExternalForcesVector(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::NonLinearStatic::computeExternalLoadReactionContribution(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::Node2NodeContact::computeGap(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::IntElPoint::computeGlobalCoordinates(), oofem::Shell7Base::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::TransportElement::computeInternalSourceRhsSubVectorAt(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::PolygonLine::computeIntersectionPoints(), oofem::VTKXMLExportModule::computeIPAverage(), oofem::XfemStructuralElementInterface::computeIPAverageInTriangle(), oofem::BasicGeometry::computeLineDistance(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::MITC4Shell::computeLocalBaseVectors(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::TrabBone3D::computePlasStrainEnerDensity(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::B3Material::computeShrinkageStrainVector(), oofem::LIBeam3d2::computeStrainVector(), oofem::J2plasticMaterial::ComputeStressGradient(), oofem::J2MPlasticMaterial::computeStressGradientVector(), oofem::J2Mat::computeStressGradientVector(), oofem::RheoChainMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::RheoChainMaterial::computeTrueStressIndependentStrainVector(), oofem::NeumannMomentLoad::computeXbar(), oofem::TransportGradientDirichlet::computeXi(), oofem::J2MPlasticMaterial::computeYieldValueAt(), oofem::J2Mat::computeYieldValueAt(), oofem::J2plasticMaterial::computeYieldValueAt(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::TrabBone3D::constructPlasFlowDirec(), oofem::ContactElement::ContactElement(), oofem::ParticleGrid< Point >::createSubGrid(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::CylindricalALM::do_lineSearch(), oofem::HOMExportModule::doOutput(), oofem::TR_SHELL02::drawScalar(), oofem::TR_SHELL01::drawScalar(), oofem::LSpace::drawTriad(), oofem::Node::drawYourself(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::Shell7Base::edgeEvalInitialCovarBaseVectorsAt(), oofem::Shell7Base::edgeEvalInitialDirectorAt(), oofem::FEI3dTrQuad::edgeGiveTransformationJacobian(), oofem::FEI3dHexaQuad::edgeGiveTransformationJacobian(), oofem::FEI3dTrLin::edgeLocal2global(), oofem::FEI3dWedgeQuad::edgeLocal2global(), oofem::FEI3dWedgeLin::edgeLocal2global(), oofem::FEI3dTetQuad::edgeLocal2global(), oofem::FEI3dTrQuad::edgeLocal2global(), oofem::FEI3dHexaQuad::edgeLocal2global(), oofem::Shell7Base::evalInitialCovarBaseVectorsAt(), oofem::Shell7Base::evalInitialDirectorAt(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::DofManValueField::evaluateAt(), oofem::VTKExportModule::exportCellVars(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::ParticleTopologyDescription::findDisplacement(), oofem::ParticleTopologyDescription::getBoundingBox(), oofem::RotatingBoundary::give(), oofem::TransportGradientDirichlet::give(), oofem::PolygonLine::giveBoundingSphere(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MITC4Shell::giveDirectorVectors(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::KelvinChainMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MPSMaterial::giveEigenStrainVector(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZ::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::HeMoKunzelMaterial::giveFluxVector(), oofem::PolygonLine::giveGlobalCoordinates(), oofem::SolidShell::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::Beam3d::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector_d(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::CoupledFieldsElement::giveInternalForcesVectorGen(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::TwoFluidMaterial::giveIPValue(), oofem::TR_SHELL01::giveIPValue(), oofem::TR_SHELL02::giveIPValue(), oofem::AbaqusUserMaterial::giveIPValue(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::GradDpElement::giveNonlocalInternalForcesVector(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::LinearElasticMaterial::giveRealStressVector_1d(), oofem::ConcreteDPM2::giveRealStressVector_1d(), oofem::LinearElasticMaterial::giveRealStressVector_2dBeamLayer(), oofem::LinearElasticMaterial::giveRealStressVector_3d(), oofem::TutorialMaterial::giveRealStressVector_3d(), oofem::SimpleVitrificationMaterial::giveRealStressVector_3d(), oofem::TrabBoneNL3D::giveRealStressVector_3d(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::TrabBone3D::giveRealStressVector_3d(), oofem::ConcreteDPM2::giveRealStressVector_3d(), oofem::LinearElasticMaterial::giveRealStressVector_3dDegeneratedShell(), oofem::LinearElasticMaterial::giveRealStressVector_Fiber(), oofem::LinearElasticMaterial::giveRealStressVector_PlaneStrain(), oofem::LinearElasticMaterial::giveRealStressVector_PlaneStress(), oofem::LinearElasticMaterial::giveRealStressVector_PlateLayer(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::TrabBoneGrad3D::giveRealStressVectorGrad(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::PolygonLine::giveSubPolygon(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::PrescribedGradientBCWeak::giveTractionElArcPos(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEInterpolation2d::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::SlaveNode::initializeFrom(), oofem::IntMatIsoDamageTable::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::BoundaryCondition::initializeFrom(), oofem::IsoInterfaceDamageMaterial_2::initializeFrom(), oofem::StokesFlowVelocityHomogenization::integrateNMatrix(), oofem::MMAShapeFunctProjection::interpolateIntVarAt(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::FEI3dHexaLin::local2global(), oofem::FEI3dTetLin::local2global(), oofem::FEI3dTetQuad::local2global(), oofem::FEI3dTrLin::local2global(), oofem::FEI3dLineLin::local2global(), oofem::FEI3dTrQuad::local2global(), oofem::FEI3dWedgeLin::local2global(), oofem::FEI3dHexaQuad::local2global(), oofem::BSplineInterpolation::local2global(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::QPlaneStress2d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Q9PlaneStress2d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::NCPrincipalStrain::nucleateEnrichmentItems(), oofem::NCPrincipalStress::nucleateEnrichmentItems(), oofem::operator+(), oofem::operator+=(), oofem::MisesMat::performPlasticityReturn(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::DruckerPragerPlasticitySM::performRegularReturn(), oofem::ConcreteDPM::performRegularReturn(), oofem::DustMaterial::performStressReturn(), oofem::Triangle::pointIsInTriangle(), oofem::TR_SHELL02::printOutputAt(), oofem::ConcreteDPM2Status::printOutputAt(), oofem::NonLinearDynamic::proceedStep(), oofem::NonLinearStatic::proceedStep(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::GeometryBasedEI::propagateFronts(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::Triangle::refineTriangle(), oofem::BinghamFluidMaterial2Status::restoreContext(), oofem::BoundaryCondition::setPrescribedValue(), oofem::Shell7Base::setupInitialNodeDirectors(), oofem::Subdivision::smoothMesh(), oofem::DynamicRelaxationSolver::solve(), oofem::LineSearchNM::solve(), oofem::FETISolver::solve(), oofem::StaggeredSolver::solve(), oofem::NRSolver::solve(), oofem::CylindricalALM::solve(), oofem::DEIDynamic::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::NlDEIDynamic::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::CBS::solveYourselfAt(), oofem::TR_SHELL01::SpatialLocalizerI_giveBBox(), oofem::TR_SHELL02::SpatialLocalizerI_giveBBox(), oofem::FEI3dTrLin::surfaceEvalBaseVectorsAt(), oofem::FEI3dTrQuad::surfaceEvalBaseVectorsAt(), oofem::FEI3dHexaTriQuad::surfaceEvalNormal(), oofem::FEI3dHexaLin::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dTetQuad::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::FEI3dTrLin::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dTetQuad::surfaceLocal2global(), oofem::FEI3dTrQuad::surfaceLocal2global(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::Subdivision::unpackSharedIrregulars(), oofem::TransientTransportProblem::updateComponent(), oofem::NonLinearDynamic::updateComponent(), oofem::NonLinearStatic::updateLoadVectors(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::SUPG::updateSolutionVectors(), oofem::PerfectlyPlasticMaterialStatus::updateYourself(), oofem::MPSMaterialStatus::updateYourself(), oofem::ParticleTopologyDescription::updateYourself(), oofem::TransportExternalForceAssembler::vectorFromElement(), oofem::IntermediateConvectionDiffusionAssembler::vectorFromElement(), oofem::DensityRhsAssembler::vectorFromElement(), oofem::Shell7Base::vtkEvalInitialGlobalCoordinateAt(), oofem::Shell7Base::vtkEvalInitialGlobalCZCoordinateAt(), and oofem::Shell7BaseXFEM::vtkEvalUpdatedGlobalCoordinateAt().

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 198 of file floatarray.C.

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

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

Adds scalar to receiver.

Parameters
offsetScalar to add

Definition at line 190 of file floatarray.C.

void oofem::FloatArray::addSubVector ( const FloatArray src,
int  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 399 of file floatarray.C.

References giveSize(), and resizeWithValues().

Referenced by oofem::Node2NodeContactL::computeContactForces(), oofem::ContactElement::ContactElement(), oofem::HeMoBazNajMaterial::giveFluxVector(), oofem::HeMoTKMaterial::giveFluxVector(), and oofem::HeMoKunzelMaterial::giveFluxVector().

void oofem::FloatArray::append ( const FloatArray a)
void oofem::FloatArray::append ( double  a)

Appends value to reciever.

Parameters
aValue to be appended.

Definition at line 670 of file floatarray.C.

References values.

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 551 of file floatarray.C.

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

Referenced by oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::LinearConstraintBC::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::EngngModel::assembleVectorFromElements(), oofem::TR_SHELL01::computeBodyLoadVectorAt(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::ContactDefinition::computeContactForces(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::PFEMElement::computeLoadVector(), oofem::DofManager::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::SUPGElement2::giveCharacteristicVector(), oofem::PFEMElement::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::TR_SHELL02::giveCharacteristicVector(), oofem::TR_SHELL01::giveCharacteristicVector(), oofem::PrescribedMean::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::StructuralMaterial::giveFullSymVectorForm(), oofem::StructuralMaterial::giveFullVectorForm(), oofem::Shell7BaseXFEM::giveInternalForcesVector(), oofem::GradDpElement::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::IntElLine1PF::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::GradDpElement::giveLocalInternalForcesVector(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Shell7Base::giveUpdatedSolutionVector(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::StaggeredSolver::solve(), oofem::PFEMPressureRhsAssembler::vectorFromElement(), and oofem::SUPGInternalForceAssembler::vectorFromElement().

double& oofem::FloatArray::at ( int  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 131 of file floatarray.h.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMALeastSquareProjection::__mapVariable(), oofem::SparseMtrx::addDiagonal(), oofem::WeakPeriodicBoundaryCondition::addElementSide(), oofem::FloatMatrix::addSubVectorCol(), oofem::FloatMatrix::addSubVectorRow(), oofem::PrimaryField::applyBoundaryCondition(), oofem::SymmetryBarrier::applyConstraint(), oofem::NRSolver::applyConstraintsToLoadIncrement(), oofem::MDM::applyDamageToStiffness(), oofem::MDM::applyDamageTranformation(), oofem::PrimaryField::applyDefaultInitialCondition(), oofem::SUPG::applyIC(), oofem::NonStationaryTransportProblem::applyIC(), oofem::CBS::applyIC(), oofem::PFEM::applyIC(), oofem::PrimaryField::applyInitialCondition(), oofem::SparseNonLinearSystemNM::applyPerturbation(), oofem::DynCompRow::assemble(), oofem::DynCompCol::assemble(), oofem::LinearConstraintBC::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), assemble(), oofem::TransportElement::assembleLocalContribution(), assembleSquared(), oofem::LinearConstraintBC::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::MixedGradientPressureDirichlet::assembleVector(), oofem::DynCompRow::at(), oofem::DynCompCol::at(), oofem::FloatMatrix::beDyadicProductOf(), oofem::FloatMatrix::beLocalCoordSys(), oofem::FloatMatrix::beMatrixForm(), oofem::FloatMatrix::beMatrixFormOfStress(), beProductOf(), 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::ElementErrorCheckingRule::check(), oofem::BeamElementErrorCheckingRule::check(), oofem::ReactionErrorCheckingRule::check(), oofem::NRSolver::checkConvergence(), oofem::CylindricalALM::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::ConcreteDPM2::checkForUnAndReloading(), oofem::RCM2Material::checkIfClosedCracks(), oofem::ConcreteFCM::checkSnapBack(), oofem::CompoDamageMat::checkSnapBack(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::Delaunay::colinear(), oofem::ConcreteDPM2::compute3dSecantStiffness(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAccelerationTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MC(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::ConcreteDPM2::computeAlpha(), oofem::IDNLMaterial::computeAngleAndSigmaRatio(), oofem::FRCFCMNL::computeAngleBetweenVectors(), oofem::IntElLine1PhF::computeAreaAround(), oofem::IntElLine1::computeAreaAround(), oofem::Tr2Shell7XFEM::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::MPSMaterial::computeB4AutogenousShrinkageStrainVector(), oofem::Triangle::computeBarycentrCoor(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue1D(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue2D(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::DelaunayTriangulator::computeBBXBasedOnNodeData(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBmatrixAt(), oofem::CohesiveSurface3d::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::Tr_Warp::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::MITC4Shell::computeBmatrixAt(), oofem::RerShell::computeBmatrixAt(), oofem::Lattice2d::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::TransportElement::computeBodyBCSubVectorAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::HeMoTKMaterial::computeCapacityCoeff(), oofem::HeMoKunzelMaterial::computeCapacityCoeff(), oofem::NlIsoMoistureMaterial::computeCapTranspCoeff(), oofem::TR21_2D_SUPG::computeCenterOf(), oofem::Triangle::computeCenterOfCircumCircle(), oofem::FreeWarping::computeCenterOfGravity(), oofem::KelvinChainMaterial::computeCharCoefficients(), oofem::MaxwellChainMaterial::computeCharCoefficients(), oofem::B3SolidMaterial::computeCharCoefficients(), oofem::Eurocode2CreepMaterial::computeCharCoefficients(), oofem::MPSMaterial::computeCharCoefficients(), oofem::B3SolidMaterial::computeCharTimes(), oofem::Eurocode2CreepMaterial::computeCharTimes(), oofem::RheoChainMaterial::computeCharTimes(), oofem::Node2NodeContact::computeCmatrixAt(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeCohesiveNmatrixAt(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::Node2NodeContact::computeContactForces(), oofem::Node2NodeContactL::computeContactForces(), oofem::Node2NodeContact::computeContactTangent(), oofem::Node2NodeContactL::computeContactTangent(), oofem::Node2NodeContact::computeContactTractionAt(), oofem::Node2NodeContactL::computeContactTractionAt(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::TR21_2D_SUPG::computeCoordsOfEdge(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::TR1_2D_CBS::computeCorrectionRhs(), oofem::IntElLine1IntPen::computeCovarBaseVectorAt(), oofem::IntElLine2IntPen::computeCovarBaseVectorAt(), oofem::IntElLine1PF::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorAt(), oofem::IntElLine1::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorsAt(), oofem::FRCFCM::computeCrackFibreAngle(), oofem::EnrichmentFront::computeCrackTangent(), oofem::TR1_2D_SUPG::computeCriticalLEPlicTimeStep(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::TR1_2D_CBS::computeCriticalTimeStep(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::RCSDEMaterial::computeCurrEquivStrain(), oofem::RCSDMaterial::computeCurrEquivStrain(), oofem::ConcreteFCM::computeD2ModulusForCrack(), oofem::ConcreteDPM2::computeDamage(), oofem::StructuralInterfaceElementPhF::computeDamageAt(), oofem::MDM::computeDamageOnPlane(), oofem::IntMatIsoDamageTable::computeDamageParam(), oofem::MazarsMaterial::computeDamageParam(), oofem::IsoInterfaceDamageMaterial_2::computeDamageParam(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::GradDpElement::computeDeformationGradientVector(), oofem::NLStructuralElement::computeDeformationGradientVector(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::tet21ghostsolid::computeDeformationGradientVectorFromDispl(), oofem::CylindricalALM::computeDeltaLambda(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormCompression(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormTension(), oofem::TrabBoneMaterial::computeDensification(), oofem::TrabBone3D::computeDensificationStress(), oofem::TR1_2D_CBS::computeDensityRhsPressureTerms(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::BinghamFluidMaterial2::computeDeviatoricStrain(), oofem::TR1_2D_SUPG::computeDeviatoricStrain(), oofem::TR1_2D_SUPG2_AXI::computeDeviatoricStress(), oofem::BinghamFluidMaterial2::computeDeviatoricStress(), oofem::TR1_2D_PFEM::computeDeviatoricStress(), oofem::TR1_2D_CBS::computeDeviatoricStress(), oofem::TR1_2D_SUPG2::computeDeviatoricStress(), oofem::TR1_2D_PFEM::computeDeviatoricStressDivergence(), oofem::NewtonianFluidMaterial::computeDeviatoricStressVector(), oofem::NonlinearFluidMaterial::computeDeviatoricStressVector(), oofem::FluidDynamicMaterial::computeDeviatoricStressVector(), oofem::FE2FluidMaterial::computeDeviatoricStressVector(), oofem::StressVector::computeDeviatoricVolumetricSplit(), oofem::StrainVector::computeDeviatoricVolumetricSplit(), oofem::StructuralMaterial::computeDeviatoricVolumetricSplit(), oofem::BinghamFluidMaterial2::computeDevStrainMagnitude(), oofem::BinghamFluidMaterial2::computeDevStressMagnitude(), oofem::TR1_2D_CBS::computeDiagonalMassMtrx(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::AnisotropicDamageMaterial::computeDimensionlessOutOfPlaneStress(), oofem::RheoChainMaterial::computeDiscreteRelaxationFunction(), oofem::Line::computeDistanceTo(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::ActiveDof::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::Dof::computeDofTransformation(), oofem::HeMoKunzelMaterial::computeDw(), oofem::SolidShell::computeEASBmatrixAt(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::DKTPlate::computeEdgeNMatrix(), oofem::TrAxisym1_ht::computeEdgeVolumeAround(), oofem::QuadAxisym1_ht::computeEdgeVolumeAround(), oofem::TrPlanestressRotAllman::computeEgdeNMatrixAt(), oofem::FRCFCMNL::computeElementCentroid(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IntMatIsoDamage::computeEquivalentJump(), oofem::Eurocode2CreepMaterial::computeEquivalentMaturity(), oofem::MazarsMaterial::computeEquivalentStrain(), oofem::IsoInterfaceDamageMaterial::computeEquivalentStrain(), oofem::IsoInterfaceDamageMaterial_2::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::AnisotropicDamageMaterial::computeEquivalentStrain(), oofem::LatticeDamage2d::computeEquivalentStrain(), oofem::RankineMat::computeEta(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::SolidShell::computeEVector(), oofem::MPSMaterial::computeFibAutogenousShrinkageStrainVector(), oofem::QTruss1dGrad::computeField(), oofem::Hexa21Stokes::computeField(), oofem::Tr1BubbleStokes::computeField(), oofem::Tr21Stokes::computeField(), oofem::Tet1BubbleStokes::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::IntElLine1PF::computeFreeEnergy(), oofem::SolidShell::computeFVector(), oofem::Node2NodeContact::computeGap(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::IntElSurfTr1::computeGlobalCoordinates(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::InterfaceElement3dTrLin::computeGlobalCoordinates(), oofem::LIBeam2dNL::computeGlobalCoordinates(), oofem::Shell7Base::computeGlobalCoordinates(), oofem::Lattice2d::computeGlobalCoordinates(), oofem::LIBeam2d::computeGlobalCoordinates(), oofem::LIBeam3d::computeGlobalCoordinates(), oofem::Truss2d::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::LIBeam3dNL2::computeGlobalCoordinates(), oofem::LIBeam3dNL::computeGlobalCoordinates(), oofem::Lattice2d_mt::computeGlobalCoordinates(), oofem::LIBeam3d2::computeGlobalCoordinates(), oofem::Beam3d::computeGlobalCoordinates(), oofem::CCTPlate3d::computeGlobalCoordinates(), oofem::DKTPlate3d::computeGlobalCoordinates(), oofem::MITC4Shell::computeGlobalCoordinates(), oofem::IntElLine1PF::computeGMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::PlasticMaterial::ComputeGradientVector(), oofem::MPlasticMaterial::computeGradientVector(), oofem::Tet1_3D_SUPG::computeGradUMatrix(), oofem::TR21_2D_SUPG::computeGradUMatrix(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::InterfaceElem2dLin::computeGtoLRotationMatrix(), oofem::InterfaceElem2dQuad::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::SpringElement::computeGtoLRotationMatrix(), oofem::MITC4Shell::computeGtoLRotationMatrix(), oofem::TR1_2D_SUPG::computeHomogenizedReinforceTerm_MB(), oofem::TR1_2D_SUPG::computeHomogenizedReinforceTerm_MC(), oofem::Line::computeInclinationAngle(), oofem::Eurocode2CreepMaterial::computeIncrementOfAutogenousShrinkageVector(), oofem::Eurocode2CreepMaterial::computeIncrementOfDryingShrinkageVector(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::NLStructuralElement::computeInitialStressMatrix(), oofem::AnisotropicDamageMaterial::computeInplaneStress(), oofem::Shell7BaseXFEM::computeInterfaceJumpAt(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::TransportElement::computeInternalSourceRhsSubVectorAt(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::HydratingConcreteMat::computeInternalSourceVector(), oofem::CemhydMat::computeInternalSourceVector(), oofem::TR21_2D_SUPG::computeIntersection(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Line::computeIntersectionPoints(), oofem::Circle::computeIntersectionPoints(), oofem::PolygonLine::computeIntersectionPoints(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::Steel1::computeJ2InvariantAt(), oofem::J2MPlasticMaterial::computeJ2InvariantAt(), oofem::J2plasticMaterial::computeJ2InvariantAt(), oofem::J2Mat::computeJ2InvariantAt(), oofem::ConcreteDPM2::computeJacobian(), oofem::J2Mat::computeKGradientVector(), oofem::Masonry02::computeKGradientVector(), oofem::DruckerPragerCutMat::computeKGradientVector(), oofem::Shell7Base::computeLambdaNMatrix(), oofem::InterfaceElement3dTrLin::computeLCS(), oofem::Quad1MindlinShell3D::computeLCS(), oofem::TR1_2D_SUPG_AXI::computeLinearAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeLinearAdvectionTerm_MC(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::tet21ghostsolid::computeLoadVector(), oofem::TR1_2D_SUPG_AXI::computeLoadVector(), oofem::TR1_2D_SUPG::computeLoadVector(), oofem::RerShell::computeLocalCoordinates(), oofem::Lattice2d_mt::computeLocalCoordinates(), oofem::CCTPlate3d::computeLocalCoordinates(), oofem::CCTPlate::computeLocalCoordinates(), oofem::DKTPlate3d::computeLocalCoordinates(), oofem::MITC4Shell::computeLocalCoordinates(), oofem::QDKTPlate::computeLocalCoordinates(), oofem::DKTPlate::computeLocalCoordinates(), oofem::MDM::computeLocalDamageTensor(), oofem::InterfaceElem1d::computeLocalSlipDir(), oofem::IntElPoint::computeLocalSlipDir(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::RigidArmNode::computeMasterContribution(), oofem::TR21_2D_SUPG::computeMiddlePointOnParabolicArc(), oofem::LinearEdgeLoad::computeNArray(), oofem::XfemElementInterface::computeNCohesive(), oofem::TrPlaneStrRot::computeNmatrixAt(), oofem::TrPlanestressRotAllman::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::CCTPlate::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::LIBeam2d::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::LIBeam2dNL::computeNmatrixAt(), oofem::LIBeam3d::computeNmatrixAt(), oofem::Truss1d::computeNmatrixAt(), oofem::Truss2d::computeNmatrixAt(), oofem::MITC4Shell::computeNmatrixAt(), oofem::LIBeam3dNL2::computeNmatrixAt(), oofem::LIBeam3dNL::computeNmatrixAt(), oofem::RerShell::computeNmatrixAt(), oofem::LIBeam3d2::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::TR1_2D_SUPG::computeNMtrx(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::FRCFCMNL::computeNonlocalStressInFibersInUncracked(), oofem::PolygonLine::computeNormalSignDist(), oofem::MicroplaneMaterial::computeNormalStrainComponent(), oofem::MicroplaneMaterial::computeNormalVolumetricStrainComponent(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::PhaseFieldElement::computeNStress_d(), oofem::Lattice2d_mt::computeNSubMatrixAt(), oofem::TR1_2D_CBS::computeNumberOfNodalPrescribedTractionPressureContributions(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::WeakPeriodicBoundaryCondition::computeOrthogonalBasis(), oofem::TR1_2D_SUPG_AXI::computeOutFlowBCTerm_MB(), oofem::AnisotropicDamageMaterial::computeOutOfPlaneStrain(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::TR1_2D_SUPG_AXI::computePenetrationWithResistanceBCTerm_MB(), oofem::AnisotropicDamageMaterial::computePlaneStressSigmaZ(), oofem::AnisotropicDamageMaterial::computePlaneStressStrain(), oofem::PerfectlyPlasticMaterial::computePlasticStiffnessAt(), oofem::DustMaterial::computePlastStrainDirM1(), oofem::DustMaterial::computePlastStrainDirM2(), oofem::DustMaterial::computePlastStrainDirM3(), oofem::B3SolidMaterial::computePointShrinkageStrainVector(), oofem::MPSMaterial::computePointShrinkageStrainVector(), oofem::SPRNodalRecoveryModel::computePolynomialTerms(), oofem::MMALeastSquareProjection::computePolynomialTerms(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computePressureForceAt(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::TR1_2D_SUPG_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MB(), oofem::TR1_2D_SUPG::computePressureTerm_MB(), oofem::TR1_2D_SUPG2::computePressureTerm_MB(), oofem::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::computeQuadraticRoots(), oofem::LIBeam3dNL2::computeQuaternionFromRotMtrx(), oofem::TrAxisym1_ht::computeRadiusAt(), oofem::QuadAxisym1_ht::computeRadiusAt(), oofem::TR1_2D_SUPG_AXI::computeRadiusAt(), oofem::ConcreteDPM2::computeRateFactor(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::Masonry02::computeReducedSKGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::PlasticMaterial::ComputeResidualVector(), oofem::MPlasticMaterial::computeResidualVector(), oofem::MPlasticMaterial2::computeResidualVector(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::LIBeam3dNL2::computeRotMtrxFromQuaternion(), oofem::AnisotropicDamageMaterial::computeSecantOperator(), oofem::DKTPlate::computeShearForces(), oofem::MicroplaneMaterial::computeShearLStrainComponent(), oofem::MicroplaneMaterial::computeShearMStrainComponent(), oofem::B3Material::computeShrinkageStrainVector(), oofem::TR1_2D_SUPG_AXI::computeSlipWithFrictionBCTerm_MB(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::TutorialMaterial::computeSphDevPartOf(), oofem::SpringElement::computeSpringInternalForce(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::LIBeam3dNL2::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::J2Mat::computeStrainHardeningVarsIncrement(), oofem::Masonry02::computeStrainHardeningVarsIncrement(), oofem::DruckerPragerCutMat::computeStrainHardeningVarsIncrement(), oofem::IsotropicDamageMaterial1::computeStrainInvariants(), oofem::LIBeam3dNL::computeStrainVector(), oofem::LIBeam3dNL2::computeStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::MicroplaneMaterial::computeStrainVectorComponents(), oofem::LIBeam2d::computeStrainVectorInLayer(), oofem::LIBeam2dNL::computeStrainVectorInLayer(), oofem::RerShell::computeStrainVectorInLayer(), oofem::TrPlanestressRotAllman::computeStrainVectorInLayer(), oofem::CCTPlate::computeStrainVectorInLayer(), oofem::QDKTPlate::computeStrainVectorInLayer(), oofem::Beam2d::computeStrainVectorInLayer(), oofem::DKTPlate::computeStrainVectorInLayer(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::IDNLMaterial::computeStressBasedWeight(), oofem::IDNLMaterial::computeStressBasedWeightForPeriodicCell(), oofem::J2plasticMaterial::ComputeStressGradient(), oofem::J2MPlasticMaterial::computeStressGradientVector(), oofem::RankinePlasticMaterial::computeStressGradientVector(), oofem::J2Mat::computeStressGradientVector(), oofem::DruckerPragerCutMat::computeStressGradientVector(), oofem::Masonry02::computeStressGradientVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::LatticeDamage2d::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::SteelRelaxMat::computeStressRelaxationStrainVector(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVarsReducedGradient(), oofem::LineDistributedSpring::computeStressVector(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::MITC4Shell::computeSurfaceNMatrixAt(), oofem::MITC4Shell::computeSurfaceVolumeAround(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::LIBeam3dNL::computeTempCurv(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::B3Material::computeTotalAverageShrinkageStrainVector(), oofem::B3SolidMaterial::computeTotalAverageShrinkageStrainVector(), oofem::IntMatBilinearCZ::computeTraction(), oofem::Shell7Base::computeTractionForce(), oofem::IntElLine1PF::computeTransformationMatrixAt(), oofem::IntElLine1PhF::computeTransformationMatrixAt(), oofem::IntElLine1::computeTransformationMatrixAt(), oofem::IntElPoint::computeTransformationMatrixAt(), oofem::RheoChainMaterial::computeTrueStressIndependentStrainVector(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::TF1::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::GravityPressure::computeValueAt(), oofem::UserDefinedTemperatureField::computeValueAt(), oofem::BoundaryLoad::computeValueAt(), oofem::Load::computeValues(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::InterfaceElem2dLin::computeVolumeAround(), oofem::MITC4Shell::computeVolumeAround(), oofem::StressStrainBaseVector::computeVolumetricPart(), oofem::StructuralMaterial::computeVonMisesStress(), oofem::LIBeam3dNL::computeXdVector(), oofem::LIBeam3dNL2::computeXdVector(), oofem::TransportGradientDirichlet::computeXi(), oofem::RankinePlasticMaterial::computeYieldValueAt(), oofem::DruckerPragerCutMat::computeYieldValueAt(), oofem::Masonry02::computeYieldValueAt(), oofem::StructuralElement::condense(), oofem::TrabBone3D::constructAnisoFtensor(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), oofem::LargeStrainMasterMaterial::constructL1L2TransformationMatrices(), oofem::ContactElement::ContactElement(), oofem::BoundingBox::contains(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::containsPoint(), oofem::StructuralMaterial::convert_dSdE_2_dPdF(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::CylindricalALM::convertHPCMap(), oofem::SparseNonLinearSystemNM::convertPertMap(), oofem::SuperLUSolver::convertRhs(), oofem::Shell7Base::convV6ToV9Stress(), oofem::SolutionbasedShapeFunction::copyDofManagersToSurfaceData(), oofem::FloatMatrix::copySubVectorRow(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::FreemInterface::createInput(), oofem::TSplineInterpolation::createLocalKnotVector(), oofem::Subdivision::createMesh(), oofem::T3DInterface::createQCInterpolationMesh(), oofem::PrescribedGradientBCWeak::createTractionMesh(), oofem::T3DInterface::createVTKExportMesh(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::WallClockLoadBalancerMonitor::decide(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), distance_square(), oofem::OctantRec::divideLocally(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::divideLocally(), oofem::CylindricalALM::do_lineSearch(), oofem::LEPlic::doCellDLS(), oofem::GPInitModule::doInit(), oofem::LEPlic::doLagrangianPhase(), oofem::CrackExportModule::doOutput(), oofem::DofManExportModule::doOutput(), oofem::VTKExportModule::doOutput(), oofem::VTKXMLExportModule::doOutput(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::MatlabExportModule::doOutputIntegrationPointFields(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::drawIGAPatchDeformedGeometry(), oofem::Lattice2d::drawRawCrossSections(), oofem::Lattice2d_mt::drawRawCrossSections(), oofem::IGAElement::drawRawGeometry(), oofem::QTrPlaneStress2d::drawScalar(), oofem::QPlaneStrain::drawScalar(), oofem::IntElLine2::drawScalar(), oofem::QTrPlaneStrain::drawScalar(), oofem::QPlaneStress2d::drawScalar(), oofem::InterfaceElem2dLin::drawScalar(), oofem::Quad1_ht::drawScalar(), oofem::InterfaceElem2dQuad::drawScalar(), oofem::Tetrah1_ht::drawScalar(), oofem::Axisymm3d::drawScalar(), oofem::L4Axisymm::drawScalar(), oofem::TrPlaneStress2d::drawScalar(), oofem::InterfaceElem1d::drawScalar(), oofem::LTRSpace::drawScalar(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::Brick1_ht::drawScalar(), oofem::PlaneStress2d::drawScalar(), oofem::Quad1PlaneStrain::drawScalar(), oofem::PlaneStress2dXfem::drawScalar(), oofem::CohesiveSurface3d::drawScalar(), oofem::Truss1d::drawScalar(), oofem::TrPlaneStrain::drawScalar(), oofem::IntElLine1::drawScalar(), oofem::TrPlaneStress2dXFEM::drawScalar(), oofem::LSpace::drawScalar(), oofem::TR_SHELL02::drawScalar(), oofem::TR_SHELL01::drawScalar(), oofem::TR1_2D_SUPG2_AXI::drawScalar(), oofem::TR21_2D_SUPG::drawScalar(), oofem::IntElPoint::drawScalar(), oofem::LIBeam3d2::drawScalar(), oofem::Quad10_2D_SUPG::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::TR1_2D_PFEM::drawScalar(), oofem::CCTPlate::drawScalar(), oofem::QDKTPlate::drawScalar(), oofem::TR1_2D_CBS::drawScalar(), oofem::TR1_2D_SUPG2::drawScalar(), oofem::DKTPlate::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::TR1_2D_SUPG::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::TrPlaneStress2d::drawSpecial(), oofem::LTRSpace::drawSpecial(), oofem::PlaneStress2d::drawSpecial(), oofem::Quad1PlaneStrain::drawSpecial(), oofem::LSpace::drawSpecial(), oofem::Lattice2d::drawSpecial(), oofem::LSpace::drawTriad(), oofem::Node::drawYourself(), oofem::Concrete2::dtp2(), oofem::Concrete2::dtp3(), oofem::DarcyFlow::DumpMatricesToFile(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::FEI2dTrConst::edgeComputeLength(), oofem::FEI2dQuadConst::edgeComputeLength(), oofem::FEI2dTrLin::edgeComputeLength(), oofem::FEI2dQuadLin::edgeComputeLength(), oofem::FEI2dLineLin::edgeComputeLength(), oofem::Shell7Base::edgeComputeNmatrixAt(), oofem::Shell7Base::edgeEvalCovarBaseVectorsAt(), oofem::FEI2dLineHermite::edgeEvald2Nds2(), oofem::FEI2dTrQuad::edgeEvaldNds(), oofem::FEI2dLineHermite::edgeEvaldNds(), oofem::FEI2dLineLin::edgeEvaldNds(), oofem::FEI2dLineQuad::edgeEvaldNds(), oofem::FEI2dQuadQuad::edgeEvaldNds(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::FEI3dTrQuad::edgeEvaldNdxi(), oofem::Shell7BaseXFEM::edgeEvalEnrCovarBaseVectorsAt(), oofem::Shell7Base::edgeEvalInitialCovarBaseVectorsAt(), oofem::Shell7Base::edgeEvalInitialDirectorAt(), oofem::FEI3dHexaLin::edgeEvalN(), oofem::FEI2dTrConst::edgeEvalN(), oofem::FEI3dTetLin::edgeEvalN(), oofem::FEI2dQuadLin::edgeEvalN(), oofem::FEI2dTrQuad::edgeEvalN(), oofem::FEI2dTrLin::edgeEvalN(), oofem::FEI3dTrLin::edgeEvalN(), oofem::FEI3dWedgeQuad::edgeEvalN(), oofem::FEI3dTrQuad::edgeEvalN(), oofem::FEI3dTetQuad::edgeEvalN(), oofem::FEI3dWedgeLin::edgeEvalN(), oofem::FEI2dQuadQuad::edgeEvalN(), oofem::FEI3dHexaQuad::edgeEvalN(), oofem::FEI2dQuadLin::edgeEvalNormal(), oofem::FEI2dTrQuad::edgeEvalNormal(), oofem::FEI2dLineHermite::edgeEvalNormal(), oofem::FEI2dLineLin::edgeEvalNormal(), oofem::FEI2dLineQuad::edgeEvalNormal(), oofem::FEI2dQuadQuad::edgeEvalNormal(), oofem::FEI3dTrQuad::edgeGiveTransformationJacobian(), oofem::FEI2dTrLinAxi::edgeGiveTransformationJacobian(), oofem::FEI3dHexaQuad::edgeGiveTransformationJacobian(), oofem::FEI2dQuadLinAxi::edgeGiveTransformationJacobian(), oofem::FEI2dQuadQuadAxi::edgeGiveTransformationJacobian(), oofem::FEI3dHexaLin::edgeLocal2global(), oofem::FEI3dTetLin::edgeLocal2global(), oofem::FEI2dTrConst::edgeLocal2global(), oofem::FEI2dQuadLin::edgeLocal2global(), oofem::FEI2dTrQuad::edgeLocal2global(), oofem::FEI3dWedgeQuad::edgeLocal2global(), oofem::FEI2dTrLin::edgeLocal2global(), oofem::FEI3dWedgeLin::edgeLocal2global(), oofem::FEI2dQuadQuad::edgeLocal2global(), oofem::FEI3dHexaQuad::edgeLocal2global(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::tet21ghostsolid::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::Tet21Stokes::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::ZZErrorEstimator::estimateError(), oofem::HuertaErrorEstimator::estimateError(), oofem::DirectErrorIndicatorRC::estimateMeshDensities(), oofem::ZZRemeshingCriteria::estimateMeshDensities(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::ScalarFunction::eval(), oofem::FEI2dTrQuad::evald2Ndx2(), oofem::FEI1dHermite::evald2Ndx2(), oofem::NURBSInterpolation::evaldNdx(), oofem::FEI3dTetLin::evaldNdx(), oofem::FEI2dTrLin::evaldNdx(), oofem::FEI2dTrQuad::evaldNdx(), oofem::FEI2dQuadLin::evaldNdx(), oofem::FEI3dLineLin::evaldNdx(), oofem::FEI1dHermite::evaldNdx(), oofem::FEI1dLin::evaldNdx(), oofem::FEI1dQuad::evaldNdx(), oofem::FEI2dQuadQuad::evaldNdx(), oofem::FEI2dLineHermite::evaldNdx(), oofem::TSplineInterpolation::evaldNdx(), oofem::BSplineInterpolation::evaldNdx(), oofem::FEI2dTrQuad::evaldNdxi(), oofem::FEI2dQuadQuad::evaldNdxi(), oofem::PrescribedGenStrainShell7::evalInitialCovarBaseVectorsAt(), oofem::Shell7Base::evalInitialDirectorAt(), oofem::NURBSInterpolation::evalN(), oofem::FEI2dQuadConst::evalN(), oofem::FEI3dHexaLin::evalN(), oofem::FEI3dTetLin::evalN(), oofem::FEI3dHexaTriQuad::evalN(), oofem::FEI2dTrQuad::evalN(), oofem::FEI2dTrLin::evalN(), oofem::FEI2dQuadLin::evalN(), oofem::FEI3dLineLin::evalN(), oofem::FEI1dHermite::evalN(), oofem::FEI2dQuadBiQuad::evalN(), oofem::FEI1dLin::evalN(), oofem::FEI1dQuad::evalN(), oofem::FEI3dWedgeQuad::evalN(), oofem::FEI2dQuadQuad::evalN(), oofem::FEI3dWedgeLin::evalN(), oofem::FEI2dLineHermite::evalN(), oofem::FEI2dLineLin::evalN(), oofem::TSplineInterpolation::evalN(), oofem::FEI3dHexaQuad::evalN(), oofem::BSplineInterpolation::evalN(), oofem::FEI2dQuadLin::evalNXIntegral(), oofem::FEI2dTrQuad::evalNXIntegral(), oofem::FEI2dTrLin::evalNXIntegral(), oofem::FEI2dLineQuad::evalNXIntegral(), oofem::FEI2dLineLin::evalNXIntegral(), oofem::FEI3dTetLin::evalNXIntegral(), oofem::FEI2dQuadQuad::evalNXIntegral(), oofem::InterpolatingFuction::evaluate(), oofem::CalculatorFunction::evaluate(), oofem::InsertNode::evaluate(), oofem::InsertTriangleBasedOnCircumcircle::evaluate(), oofem::ElementCircumCirclesContainingNode::evaluate(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::DofManValueField::evaluateAt(), oofem::UnstructuredGridField::evaluateAt(), oofem::PiecewiseLinFunction::evaluateAtTime(), oofem::PeriodicPiecewiseLinFunction::evaluateAtTime(), oofem::Function::evaluateAtTime(), oofem::CohesiveSurface3d::evaluateCenter(), oofem::EnrFrontIntersection::evaluateEnrFuncAt(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncAt(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncAt(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncAt(), oofem::Delamination::evaluateEnrFuncAt(), oofem::RampFunction::evaluateEnrFuncDerivAt(), oofem::DamagedNeighborLayered::evaluateFailureCriteria(), oofem::PrescribedGenStrainShell7::evaluateHigherOrderContribution(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::CohesiveSurface3d::evaluateLocalCoordinateSystem(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::RankineMat::evaluatePlaneStressStiffMtrx(), oofem::PiecewiseLinFunction::evaluateVelocityAtTime(), oofem::PeriodicPiecewiseLinFunction::evaluateVelocityAtTime(), oofem::RankineMat::evalYieldFunction(), oofem::VTKExportModule::exportCellVars(), oofem::VTKXMLExportModule::exportExternalForces(), oofem::POIExportModule::exportIntVarAs(), oofem::VTKExportModule::exportIntVarAs(), oofem::POIExportModule::exportIntVars(), oofem::VTKExportModule::exportPrimVarAs(), oofem::HuertaErrorEstimator::extractVectorFrom(), oofem::SkylineUnsym::factorized(), oofem::LIBeam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LIBeam3d2::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::Beam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LEPlic::findCellLineConstant(), oofem::ParticleTopologyDescription::findDisplacement(), oofem::QClinearStatic::findNearestParticle(), oofem::PrescribedGradientBCPeriodic::findSlaveToMasterMap(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::LevelSetPCS::FMMReinitialization(), oofem::TR1_2D_CBS::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG2_AXI::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG2::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG::formVolumeInterfacePoly(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase2D(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase3D(), oofem::RheoChainMaterial::generateLogTimeScale(), oofem::ParticleTopologyDescription::generateMesh(), oofem::VTKXMLExportModule::getCellVariableFromIS(), oofem::PythonExpression::getDict(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKXMLExportModule::getNodalVariableFromIS(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLExportModule::getNodalVariableFromXFEMST(), oofem::InteractionBoundaryCondition::give(), oofem::PrescribedGradient::give(), oofem::RotatingBoundary::give(), oofem::PrescribedGenStrainShell7::give(), oofem::BoundaryCondition::give(), oofem::IDGMaterial::give1dGprime(), oofem::MisesMatGrad::give1dGprime(), oofem::IDGMaterial::give1dKappaMatrix(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng_Num(), oofem::MisesMatGrad::give1dStressStiffMtrx(), oofem::MisesMat::give1dStressStiffMtrx(), oofem::MisesMatNl::give1dStressStiffMtrx(), oofem::TrabBoneMaterial::give1dStressStiffMtrx(), oofem::AnisotropicDamageMaterial::give1dStressStiffMtrx(), oofem::ConcreteDPM2::give1dStressStiffMtrx(), oofem::LayeredCrossSection::give2dBeamStiffMtrx(), oofem::LayeredCrossSection::give2dPlateStiffMtrx(), oofem::WinklerMaterial::give2dPlateSubSoilStiffMtrx(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_dTdj_Num(), oofem::IntMatIsoDamage::give2dStiffnessMatrix_Eng(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng_Num(), oofem::FiberedCrossSection::give3dBeamStiffMtrx(), oofem::TrabBoneGrad3D::give3dGprime(), oofem::MisesMatGrad::give3dGprime(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::MisesMatGrad::give3dKappaMatrix(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::HyperElasticMaterial::give3dMaterialStiffnessMatrix(), oofem::TutorialMaterial::give3dMaterialStiffnessMatrix(), oofem::SimpleVitrificationMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::AnisotropicDamageMaterial::give3dMaterialStiffnessMatrix(), oofem::MooneyRivlinMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::LayeredCrossSection::give3dShellStiffMtrx(), oofem::IntMatBilinearCZElastic::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_dTdj_Num(), oofem::CohesiveInterfaceMaterial::give3dStiffnessMatrix_Eng(), oofem::IntMatPhaseField::give3dStiffnessMatrix_Eng(), oofem::SimpleInterfaceMaterial::give3dStiffnessMatrix_Eng(), oofem::ExpCZMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial_2::give3dStiffnessMatrix_Eng(), oofem::IntMatIsoDamage::give3dStiffnessMatrix_Eng(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_Eng_Num(), oofem::FEI2dQuadLin::giveArea(), oofem::FEI2dTrQuad::giveArea(), oofem::FEI2dTrLin::giveArea(), oofem::FEI2dQuadQuad::giveArea(), oofem::TrPlaneStrRot::giveArea(), oofem::FEI3dTrQuad::giveArea(), oofem::RerShell::giveArea(), oofem::FiberedCrossSection::giveArea(), oofem::CemhydMatStatus::giveAverageTemperature(), oofem::Shell7BaseXFEM::giveAverageTransverseInterfaceStress(), oofem::Shell7Base::giveAxialMatrix(), oofem::UnstructuredGridField::Cell::giveBoundingBox(), oofem::Element::giveCharacteristicLengthForAxisymmElements(), oofem::Element::giveCharacteristicLengthForPlaneElements(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::MITC4Shell::giveCharacteristicTensor(), oofem::HydratingHeMoMaterial::giveCharacteristicValue(), oofem::HydratingConcreteMat::giveCharacteristicValue(), oofem::HydratingIsoHeatMaterial::giveCharacteristicValue(), oofem::CemhydMat::giveCharacteristicValue(), oofem::LatticeTransportMaterial::giveCharacteristicValue(), oofem::RCM2MaterialStatus::giveCharLength(), oofem::FCMMaterialStatus::giveCharLength(), oofem::CompoDamageMat::giveCharLength(), oofem::CompoDamageMat::giveCharLengthForModes(), oofem::RheoChainMaterial::giveCharTime(), oofem::OctantRec::giveChildContainingPoint(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::giveChildContainingPoint(), oofem::DelaunayTriangle::giveCircumRadius(), oofem::DofManager::giveCompleteUnknownVector(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::Beam3d::giveCompositeExportData(), oofem::CemhydMat::giveConcreteCapacity(), oofem::CemhydMat::giveConcreteDensity(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::Node::giveCoordinate(), oofem::Subdivision::RS_Node::giveCoordinate(), oofem::ConcreteFCM::giveCrackingModulus(), oofem::FCMMaterialStatus::giveCrackStrain(), oofem::RCM2MaterialStatus::giveCrackStrain(), oofem::Lattice2d::giveCrossSectionCoordinates(), oofem::Lattice2d_mt::giveCrossSectionCoordinates(), oofem::LIBeam3d2::giveCurrentLength(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::FEI3dTrLin::giveDerivativeEta(), oofem::FEI3dTrQuad::giveDerivativeEta(), oofem::FEI2dQuadBiQuad::giveDerivatives(), oofem::TrPlaneStrRot::GiveDerivativeUX(), oofem::TrPlaneStrRot::GiveDerivativeUY(), oofem::TrPlaneStrRot::GiveDerivativeVX(), oofem::TrPlaneStrRot::GiveDerivativeVY(), oofem::FEI3dTrLin::giveDerivativeXi(), oofem::FEI3dTrQuad::giveDerivativeXi(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::BinghamFluidMaterial2::giveDeviatoricStiffnessMatrix(), oofem::MITC4Shell::giveDirectorVectors(), oofem::TransientTransportProblem::giveDiscreteTime(), oofem::IncrementalLinearStatic::giveDiscreteTime(), oofem::NonStationaryTransportProblem::giveDiscreteTime(), oofem::StaggeredProblem::giveDiscreteTime(), oofem::DelaunayTriangle::giveDistanceToCenter(), oofem::Shell7BaseXFEM::giveDisUnknownsAt(), oofem::MITC4Shell::givedNdx(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::BinghamFluidMaterial2::giveEffectiveViscosity(), oofem::EigenValueDynamic::giveEigenValue(), oofem::LinearStability::giveEigenValue(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::ZZErrorEstimator::giveElementError(), oofem::HuertaErrorEstimator::giveElementError(), oofem::LevelSetPCS::giveElementMaterialMixture(), oofem::LEPlic::giveElementMaterialMixture(), oofem::StaticStructural::giveEndOfTimeOfInterest(), oofem::StructuralInterfaceMaterial::giveEngTraction_1d(), oofem::IntMatCoulombContact::giveEngTraction_1d(), oofem::CebFipSlip90Material::giveEngTraction_1d(), oofem::StructuralInterfaceMaterial::giveEngTraction_2d(), oofem::IntMatCoulombContact::giveEngTraction_2d(), oofem::CohesiveInterfaceMaterial::giveEngTraction_3d(), oofem::IntMatPhaseField::giveEngTraction_3d(), oofem::IntMatCoulombContact::giveEngTraction_3d(), oofem::SimpleInterfaceMaterial::giveEngTraction_3d(), oofem::ExpCZMaterial::giveEngTraction_3d(), oofem::BondCEBMaterial::giveEngTraction_3d(), oofem::IntMatIsoDamage::giveEngTraction_3d(), oofem::IsoInterfaceDamageMaterial_2::giveEngTraction_3d(), oofem::RheoChainMaterial::giveEparModulus(), oofem::PrescribedMean::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::FRCFCMNLStatus::giveFiberStressLoc(), oofem::FRCFCMNLStatus::giveFiberStressNL(), oofem::Shell7Base::giveFictiousCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedNodeCoordsForExport(), oofem::OOFEMTXTInputRecord::giveField(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::MooneyRivlinMaterial::giveFirstPKStressVector_PlaneStrain(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::StructuralInterfaceMaterial::giveFirstPKTraction_1d(), oofem::StructuralInterfaceMaterial::giveFirstPKTraction_2d(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZ::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZElastic::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::HeMoBazNajMaterial::giveFluxVector(), oofem::HeMoTKMaterial::giveFluxVector(), oofem::HeMoKunzelMaterial::giveFluxVector(), oofem::RVEStokesFlow::giveFluxVector(), oofem::LatticeTransportMaterial::giveFluxVector(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::Shell7Base::giveGeneralizedStrainComponents(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam2d(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam3d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::SimpleCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::SimpleCrossSection::giveGeneralizedStress_Shell(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::IntMatCoulombContact::giveGeneralStiffnessMatrix(), oofem::Element::giveGlobalIPValue(), oofem::Shell7Base::giveGlobalZcoord(), oofem::Lattice2d::giveGpCoordinates(), oofem::Lattice2d_mt::giveGpCoordinates(), oofem::BazantNajjarMoistureTransferMaterial::giveHumidity(), oofem::HeMoTKMaterial::giveHumidity(), oofem::NlIsoMoistureMaterial::giveHumidity(), oofem::HeMoKunzelMaterial::giveHumidity(), oofem::B3SolidMaterial::giveHumidity(), oofem::MPSMaterial::giveHumidity(), oofem::B3SolidMaterial::giveHumidityIncrement(), oofem::AnisotropicLinearElasticMaterial::giveInputRecord(), oofem::StructuralInterfaceMaterial::giveInputRecord(), oofem::PolygonLine::giveInputRecord(), oofem::Element::giveInputRecord(), oofem::LayeredCrossSection::giveInterfaceXiCoords(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::NodalSpringElement::giveInternalForcesVector(), oofem::GradDpElement::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::SpringElement::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::LIBeam3dNL2::giveInternalForcesVector(), oofem::LIBeam3dNL::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::IDGMaterial::giveInternalLength(), oofem::IDGMaterial::giveInternalLengthDerivative(), oofem::SUPGElement2::giveInternalStateAtNode(), oofem::CBSElement::giveInternalStateAtNode(), oofem::PFEMElement::giveInternalStateAtNode(), oofem::TR1_2D_PFEM::giveInternalStateAtNode(), oofem::TransportElement::giveInternalStateAtNode(), oofem::TR1_2D_CBS::giveInternalStateAtNode(), oofem::SUPGElement::giveInternalStateAtNode(), oofem::StructuralElement::giveInternalStateAtNode(), oofem::Element::giveInternalStateAtNode(), oofem::IsotropicMoistureTransferMaterial::giveIPValue(), oofem::TrPlaneStrRot3d::giveIPValue(), oofem::HydratingHeMoMaterial::giveIPValue(), oofem::IsotropicHeatTransferMaterial::giveIPValue(), oofem::TrPlaneStrRot::giveIPValue(), oofem::tet21ghostsolid::giveIPValue(), oofem::Quad1PlateSubSoil::giveIPValue(), oofem::HydratingConcreteMat::giveIPValue(), oofem::CCTPlate3d::giveIPValue(), oofem::LinQuad3DPlaneStress::giveIPValue(), oofem::TrPlanestressRotAllman3d::giveIPValue(), oofem::RerShell::giveIPValue(), oofem::Quad1Mindlin::giveIPValue(), oofem::HydratingIsoHeatMaterial::giveIPValue(), oofem::Quad10_2D_SUPG::giveIPValue(), oofem::Quad1MindlinShell3D::giveIPValue(), oofem::DKTPlate3d::giveIPValue(), oofem::CemhydMat::giveIPValue(), oofem::M1Material::giveIPValue(), oofem::FRCFCM::giveIPValue(), oofem::HeMoBazNajMaterial::giveIPValue(), oofem::RVEStokesFlow::giveIPValue(), oofem::CCTPlate::giveIPValue(), oofem::IntMatBilinearCZElastic::giveIPValue(), oofem::CebFipSlip90Material::giveIPValue(), oofem::RankineMatGrad::giveIPValue(), oofem::FRCFCMNL::giveIPValue(), oofem::TrabBoneEmbed::giveIPValue(), oofem::MITC4Shell::giveIPValue(), oofem::StructuralInterfaceCrossSection::giveIPValue(), oofem::IntMatBilinearCZ::giveIPValue(), oofem::BondCEBMaterial::giveIPValue(), oofem::QDKTPlate::giveIPValue(), oofem::MisesMat::giveIPValue(), oofem::TR1_2D_CBS::giveIPValue(), oofem::IntMatIsoDamage::giveIPValue(), oofem::IsoInterfaceDamageMaterial::giveIPValue(), oofem::Beam2d::giveIPValue(), oofem::HeMoTKMaterial::giveIPValue(), oofem::DKTPlate::giveIPValue(), oofem::TR1_2D_SUPG2::giveIPValue(), oofem::SimpleCrossSection::giveIPValue(), oofem::Beam3d::giveIPValue(), oofem::IDNLMaterial::giveIPValue(), oofem::IsoInterfaceDamageMaterial_2::giveIPValue(), oofem::FluidDynamicMaterial::giveIPValue(), oofem::HeMoKunzelMaterial::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::RankineMatNl::giveIPValue(), oofem::RankineMat::giveIPValue(), oofem::TransportMaterial::giveIPValue(), oofem::IntMatBilinearCZJansson::giveIPValue(), oofem::IntMatBilinearCZFagerstrom::giveIPValue(), oofem::CrossSection::giveIPValue(), oofem::Material::giveIPValue(), oofem::IsotropicDamageMaterial::giveIPValue(), oofem::RheoChainMaterial::giveIPValue(), oofem::RCM2Material::giveIPValue(), oofem::LayeredCrossSection::giveIPValue(), oofem::TrabBone3D::giveIPValue(), oofem::MPSDamMaterial::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::MPSMaterial::giveIPValue(), oofem::MDM::giveIPValue(), oofem::DruckerPragerPlasticitySM::giveIPValue(), oofem::LatticeDamage2d::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::DustMaterial::giveIPValue(), oofem::ConcreteDPM::giveIPValue(), oofem::Element::giveIPValue(), oofem::ConcreteDPM2::giveIPValue(), oofem::CemhydMat::giveIsotropicConductivity(), oofem::J2MPlasticMaterial::giveIsotropicHardeningVar(), oofem::J2plasticMaterial::giveIsotropicHardeningVar(), oofem::J2Mat::giveIsotropicHardeningVar(), oofem::MITC4Shell::giveJacobian(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::FEInterpolation2d::giveJacobianMatrixAt(), oofem::TSplineInterpolation::giveJacobianMatrixAt(), oofem::FEI2dLineQuad::giveJacobianMatrixAt(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::LayeredCrossSection::giveLayer(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::LayeredCrossSection::giveLayerMidZ(), oofem::LayeredCrossSection::giveLayerThickness(), oofem::FEI1dHermite::giveLength(), oofem::FEI2dLineHermite::giveLength(), oofem::FEI1dLin::giveLength(), oofem::FEI1dQuad::giveLength(), oofem::LevelSetPCS::giveLevelSetDofManValue(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::Shell7BaseXFEM::giveLocalCZNodeCoordsForExport(), oofem::FEI3dHexaTriQuad::giveLocalDerivative(), oofem::FEI3dHexaLin::giveLocalDerivative(), oofem::FEI3dWedgeQuad::giveLocalDerivative(), oofem::FEI3dWedgeLin::giveLocalDerivative(), oofem::FEI3dHexaQuad::giveLocalDerivative(), oofem::Shell7BaseXFEM::giveLocalNodeCoordsForExport(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::Shell7Base::giveMassFactorsAt(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::LEPlic::giveMaterialMixtureAt(), oofem::FCMMaterialStatus::giveMaxCrackStrain(), oofem::Shell7BaseXFEM::giveMaxCZDamages(), oofem::MDMStatus::giveMicroplaneDamage(), oofem::MicroplaneMaterial::giveMicroplaneNormal(), oofem::MDMStatus::giveMicroplaneTempDamage(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::NlIsoMoistureMaterial::giveMoistureCapacity(), oofem::GaussPoint::giveNaturalCoordinate(), oofem::StaticStructural::giveNextStep(), oofem::LevelSetPCS::giveNodalScalarRepresentation(), oofem::TrPlaneStrRot::giveNodeCoordinates(), oofem::TrPlaneStrRot3d::giveNodeCoordinates(), oofem::DKTPlate3d::giveNodeCoordinates(), oofem::CCTPlate3d::giveNodeCoordinates(), oofem::CCTPlate::giveNodeCoordinates(), oofem::QDKTPlate::giveNodeCoordinates(), oofem::DKTPlate::giveNodeCoordinates(), oofem::MITC4Shell::giveNodeCoordinates(), oofem::ConcreteFCM::giveNormalCrackingStress(), oofem::RCM2MaterialStatus::giveNumberOfActiveCracks(), oofem::NlIsoMoistureMaterial::givePermeability(), oofem::TrPlaneStrRot::GivePitch(), oofem::IDGMaterial::givePlaneStrainGprime(), oofem::MisesMatGrad::givePlaneStrainGprime(), oofem::IDGMaterial::givePlaneStrainKappaMatrix(), oofem::MooneyRivlinMaterial::givePlaneStrainStiffMtrx_dPdF(), oofem::IDGMaterial::givePlaneStressGprime(), oofem::IDGMaterial::givePlaneStressKappaMatrix(), oofem::RankineMatGrad::givePlaneStressKappaMatrix(), oofem::AnisotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::DofManager::givePrescribedUnknownVector(), oofem::LatticeTransportMaterialStatus::givePressure(), oofem::LatticeDamage2d::giveRandomParameters(), oofem::MDM::giveRawMDMParameters(), oofem::M4Material::giveRealMicroplaneStressVector(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::LayeredCrossSection::giveRealStress_3d(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), oofem::FRCFCMNL::giveRealStressVector(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::MPlasticMaterial::giveRealStressVector(), oofem::IsotropicDamageMaterial::giveRealStressVector(), oofem::MPlasticMaterial2::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::MDM::giveRealStressVector(), oofem::LatticeDamage2d::giveRealStressVector(), oofem::TrabBoneNL::giveRealStressVector_1d(), oofem::TrabBoneMaterial::giveRealStressVector_1d(), oofem::ConcreteDPM2::giveRealStressVector_1d(), oofem::MicroplaneMaterial_Bazant::giveRealStressVector_3d(), oofem::HyperElasticMaterial::giveRealStressVector_3d(), oofem::TutorialMaterial::giveRealStressVector_3d(), oofem::M1Material::giveRealStressVector_3d(), oofem::TrabBoneNL3D::giveRealStressVector_3d(), oofem::ConcreteDPM2::giveRealStressVector_3d(), oofem::AnisotropicDamageMaterial::giveRealStressVector_PlaneStress(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::DruckerPragerPlasticitySM::giveRegAlgorithmicStiffMatrix(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::DirectErrorIndicatorRC::giveRequiredDofManDensity(), oofem::ZZRemeshingCriteria::giveRequiredDofManDensity(), oofem::HuertaRemeshingCriteria::giveRequiredDofManDensity(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::FiberedCrossSection::giveSlaveGaussPoint(), oofem::LayeredCrossSection::giveSlaveGaussPoint(), oofem::Shell7Base::giveSPRcontribution(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::LayeredCrossSection::giveStiffnessMatrix_3d(), oofem::LayeredCrossSection::giveStiffnessMatrix_PlaneStress(), oofem::J2MPlasticMaterial::giveStressBackVector(), oofem::J2plasticMaterial::giveStressBackVector(), oofem::J2Mat::giveStressBackVector(), oofem::PerfectlyPlasticMaterial::GiveStressCorrectionBackToYieldSurface(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::IntMatPhaseField::giveTangents(), oofem::FCMMaterialStatus::giveTempCrackStrain(), oofem::IsotropicHeatTransferMaterial::giveTemperature(), oofem::MisesMat::giveTemperature(), oofem::MPSMaterial::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::FRCFCMNLStatus::giveTempFiberStressLoc(), oofem::FRCFCMNLStatus::giveTempFiberStressNL(), oofem::FCMMaterialStatus::giveTempMaxCrackStrain(), oofem::RCM2MaterialStatus::giveTempMaxCrackStrain(), oofem::TwoFluidMaterial::giveTempVOF(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::SimpleVitrificationMaterial::giveThermalDilatationVector(), oofem::M4Material::giveThermalDilatationVector(), oofem::IsotropicLinearElasticMaterial::giveThermalDilatationVector(), oofem::OrthotropicLinearElasticMaterial::giveThermalDilatationVector(), oofem::RheoChainMaterial::giveThermalDilatationVector(), oofem::IsotropicDamageMaterial::giveThermalDilatationVector(), oofem::StructuralMaterial::giveThermalDilatationVector(), oofem::MDM::giveThermalDilatationVector(), oofem::LatticeDamage2d::giveThermalDilatationVector(), oofem::TrAxisym1_ht::giveThicknessAt(), oofem::QuadAxisym1_ht::giveThicknessAt(), oofem::AdaptiveNonLinearStatic::giveTimeStepLoadLevel(), oofem::PolygonLine::giveTips(), oofem::CBS::giveTractionPressure(), oofem::FEI2dTrConst::giveTransformationJacobian(), oofem::FEI3dTetLin::giveTransformationJacobian(), oofem::FEI2dTrLin::giveTransformationJacobian(), oofem::FEI1dQuad::giveTransformationJacobian(), oofem::FEI1dLin::giveTransformationJacobian(), oofem::FEI2dLineHermite::giveTransformationJacobian(), oofem::FEI2dLineLin::giveTransformationJacobian(), oofem::FEI2dLineQuad::giveTransformationJacobian(), oofem::FEI2dTrLinAxi::giveTransformationJacobian(), oofem::FEI2dQuadLinAxi::giveTransformationJacobian(), oofem::FEI2dQuadQuadAxi::giveTransformationJacobian(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::MixedGradientPressureDirichlet::giveUnknown(), oofem::LinearStatic::giveUnknownComponent(), oofem::FreeWarping::giveUnknownComponent(), oofem::DEIDynamic::giveUnknownComponent(), oofem::DIIDynamic::giveUnknownComponent(), oofem::AdaptiveNonLinearStatic::giveUnknownComponent(), oofem::LinearStability::giveUnknownComponent(), oofem::NonLinearDynamic::giveUnknownComponent(), oofem::NlDEIDynamic::giveUnknownComponent(), oofem::NonLinearStatic::giveUnknownComponent(), oofem::SUPG::giveUnknownComponent(), oofem::Dof::giveUnknowns(), oofem::Shell7Base::giveUnknownsAt(), oofem::PrimaryField::giveUnknownValue(), oofem::DofManager::giveUnknownVector(), oofem::DofManager::giveUnknownVectorOfType(), oofem::CompoDamageMat::giveUnrotated3dMaterialStiffnessMatrix(), oofem::LEPlic::giveUpdatedCoordinate(), oofem::Node::giveUpdatedCoordinates(), oofem::LEPlic::giveUpdatedXCoordinate(), oofem::LEPlic::giveUpdatedYCoordinate(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::FEI3dTetQuad::giveVolume(), oofem::DustMaterialStatus::giveVolumetricPlasticStrain(), oofem::DelaunayTriangle::giveXCenterCoordinate(), oofem::DelaunayTriangle::giveYCenterCoordinate(), oofem::Steel1::GiveYCStressGradient(), oofem::Shell7Base::giveZ2integratedPolynomial2GradientForStressRecAt(), oofem::Shell7Base::giveZintegratedPolynomialGradientForStressRecAt(), oofem::FEI3dHexaLin::global2local(), oofem::FEI2dTrConst::global2local(), oofem::FEI3dTetLin::global2local(), oofem::FEI2dTrLin::global2local(), oofem::FEI2dLineLin::global2local(), oofem::FEI2dQuadLin::global2local(), oofem::FEI3dLineLin::global2local(), oofem::FEI2dLineQuad::global2local(), oofem::FEI1dHermite::global2local(), oofem::FEI2dLineHermite::global2local(), oofem::FEI3dTrQuad::global2local(), oofem::FEI1dLin::global2local(), oofem::FEI1dQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::Quad1PlaneStrain::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::PlaneStress2d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::TrPlaneStrain::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::LSpace::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::LTRSpace::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::TrPlaneStress2d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::Truss1d::HuertaErrorEstimatorI_setupRefinedElementProblem(), 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::SolutionbasedShapeFunction::init(), oofem::MazarsMaterial::initDamaged(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::ConcreteDPM::initDamaged(), oofem::ConcreteDPM2::initDamaged(), oofem::DofDistributedPrimaryField::initialize(), oofem::CompCol_ILUPreconditioner::initialize(), oofem::LevelSetPCS::initialize(), oofem::FCMMaterial::initializeCrack(), oofem::MicroplaneMaterial::initializeData(), oofem::MDM::initializeData(), oofem::PhaseFieldElement::initializeFrom(), oofem::PiecewiseLinFunction::initializeFrom(), oofem::AnisotropicMassTransferMaterial::initializeFrom(), oofem::GravityPressure::initializeFrom(), oofem::SymmetryBarrier::initializeFrom(), oofem::AnisotropicLinearElasticMaterial::initializeFrom(), oofem::Delamination::initializeFrom(), oofem::IncrementalLinearStatic::initializeFrom(), oofem::InterfaceElem1d::initializeFrom(), oofem::IGAElement::initializeFrom(), oofem::ConcreteFCM::initializeFrom(), oofem::Lattice2d_mt::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::FRCFCM::initializeFrom(), oofem::HeMoKunzelMaterial::initializeFrom(), oofem::IGATSplineElement::initializeFrom(), oofem::CemhydMat::initializeFrom(), oofem::BSplineInterpolation::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::CompoDamageMat::initializeFrom(), oofem::LevelSetPCS::initializeFrom(), oofem::NlIsoMoistureMaterial::initializeFrom(), oofem::NRSolver::initializeFrom(), oofem::Load::initializeFrom(), oofem::Node::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::PolygonLine::initializeFrom(), oofem::Element::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::DIIDynamic::initializeYourself(), oofem::NonLinearDynamic::initializeYourself(), oofem::DynCompRow::insertColInRow(), oofem::OctreeSpatialLocalizer::insertElementIntoOctree(), oofem::DynCompCol::insertRowInColumn(), oofem::FEI2dQuadConst::inside(), oofem::FEI2dTrQuad::inside(), oofem::FEI2dQuadLin::inside(), oofem::FEI2dTrLin::inside(), oofem::FEI2dQuadQuad::inside(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::HybridEI::interpGradLevelSet(), oofem::HybridEI::interpLevelSet(), oofem::HybridEI::interpLevelSetTangential(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::Quasicontinuum::intersectionTestSegmentSegment2D(), oofem::Quasicontinuum::intersectionTestSegmentTetrahedra3D(), oofem::Quasicontinuum::intersectionTestSegmentTriangle2D(), oofem::Quasicontinuum::intersectionTestSegmentTrianglePlucker3D(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::PolylineNonlocalBarrier::isActivated(), oofem::RCM2MaterialStatus::isCrackActive(), isFinite(), oofem::FRCFCMNL::isInElementProjection(), oofem::QCFullsolveddomain::isNodeInside(), oofem::Triangle::isOrientedAnticlockwise(), oofem::Line::isPointInside(), oofem::FRCFCMNL::isStrengthExceeded(), oofem::FloatMatrix::jaco_(), oofem::Skyline::ldl_feti_sky(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::NURBSInterpolation::local2global(), oofem::FEI2dQuadConst::local2global(), oofem::FEI2dTrConst::local2global(), oofem::FEI3dTetLin::local2global(), oofem::FEI3dHexaLin::local2global(), oofem::FEI2dTrLin::local2global(), oofem::FEI2dQuadLin::local2global(), oofem::FEI2dLineLin::local2global(), oofem::FEI2dTrQuad::local2global(), oofem::FEI3dTrLin::local2global(), oofem::FEI3dLineLin::local2global(), oofem::FEI3dTetQuad::local2global(), oofem::FEI2dLineQuad::local2global(), oofem::FEI2dLineHermite::local2global(), oofem::FEI3dTrQuad::local2global(), oofem::FEI1dHermite::local2global(), oofem::FEI1dQuad::local2global(), oofem::FEI3dWedgeQuad::local2global(), oofem::FEI1dLin::local2global(), oofem::FEI2dQuadQuad::local2global(), oofem::FEI3dWedgeLin::local2global(), oofem::TSplineInterpolation::local2global(), oofem::FEI3dHexaQuad::local2global(), oofem::BSplineInterpolation::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::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG_AXI::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::VTKXMLExportModule::makeFullTensorForm(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LayeredCrossSection::mapLayerGpCoordsToShellCoords(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::Shell7BaseXFEM::mapXi3FromLocalToShell(), oofem::FETISolver::masterMapDirectionVector(), oofem::FETISolver::masterMapGammas(), oofem::FETISolver::masterMapPPVector(), oofem::FETISolver::masterMapQQProduct(), oofem::FETISolver::masterMapResiduals(), oofem::FETISolver::masterMapSolution(), oofem::FETISolver::masterUnpackQQProduct(), oofem::HeMoBazNajMaterial::matcond1d(), oofem::HeMoTKMaterial::matcond1d(), oofem::HeMoKunzelMaterial::matcond1d(), oofem::HeMoBazNajMaterial::matcond2d(), oofem::HeMoTKMaterial::matcond2d(), oofem::HeMoKunzelMaterial::matcond2d(), oofem::HeMoBazNajMaterial::matcond3d(), oofem::HeMoTKMaterial::matcond3d(), oofem::HeMoKunzelMaterial::matcond3d(), oofem::MDMStatus::MDMStatus(), oofem::MDM::MMI_map(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunction_1D_Around(), oofem::MisesMatNl::modifyNonlocalWeightFunctionAround(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Hexa21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::tet21ghostsolid::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tet21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tr21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::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::DynCompRow::operator()(), oofem::DynCompCol::operator()(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputGradient(), oofem::GnuplotExportModule::outputReactionForces(), oofem::GnuplotExportModule::outputXFEM(), oofem::FETISolver::packDirectionVector(), oofem::EngngModel::packDofManagers(), oofem::FETISolver::packGammas(), oofem::NonLinearDynamic::packMigratingData(), oofem::NonLinearStatic::packMigratingData(), oofem::FETISolver::packPPVector(), oofem::FETISolver::packQQProducts(), oofem::FETISolver::packResiduals(), oofem::NodalAveragingRecoveryModel::packSharedDofManData(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::SPRNodalRecoveryModel::packSharedDofManData(), oofem::FETISolver::packSolution(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::LevelSetPCS::pcs_stage1(), oofem::MisesMat::performPlasticityReturn(), oofem::TrabBoneMaterial::performPlasticityReturn(), oofem::RankineMat::performPlasticityReturn(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::ConcreteDPM2::performRegularReturn(), oofem::DustMaterial::performStressReturn(), oofem::FloatMatrix::plusDyadSymmUpper(), oofem::FloatMatrix::plusDyadUnsym(), plusProduct(), oofem::SimpleInterfaceMaterialStatus::printOutputAt(), oofem::IntMatCoulombContactStatus::printOutputAt(), oofem::TrabBoneEmbedStatus::printOutputAt(), oofem::CompoDamageMatStatus::printOutputAt(), oofem::M1MaterialStatus::printOutputAt(), oofem::TrabBoneMaterialStatus::printOutputAt(), oofem::RerShell::printOutputAt(), oofem::EigenValueDynamic::printOutputAt(), oofem::NodalSpringElement::printOutputAt(), oofem::LineDistributedSpring::printOutputAt(), oofem::TR_SHELL01::printOutputAt(), oofem::LinearStability::printOutputAt(), oofem::IsotropicDamageMaterialStatus::printOutputAt(), oofem::AnisotropicDamageMaterialStatus::printOutputAt(), oofem::TrabBone3DStatus::printOutputAt(), oofem::MPSDamMaterialStatus::printOutputAt(), oofem::HydratingConcreteMatStatus::printOutputAt(), oofem::StructuralEngngModel::printReactionForces(), oofem::NRSolver::printState(), oofem::PolygonLine::printVTK(), oofem::OctantRec::printYourself(), oofem::NonLinearDynamic::proceedStep(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::Skyline::rbmodes(), oofem::PrimaryField::readDofManager(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::Shell7Base::recoverShearStress(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::LevelSetPCS::redistance(), oofem::M1MaterialStatus::restoreContext(), oofem::HydratingConcreteMat::scaleTemperature(), oofem::PetscSparseMtrx::scatterG2L(), oofem::LineSearchNM::search(), oofem::CylindricalALM::search(), oofem::RCM2MaterialStatus::setCharLength(), oofem::FCMMaterialStatus::setCharLength(), oofem::DelaunayTriangle::setCircumCircle(), oofem::ConcreteDPMStatus::setIPValue(), oofem::DustMaterial::setIPValue(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::FCMMaterialStatus::setMaxCrackStrain(), oofem::MDMStatus::setMicroplaneTempDamage(), oofem::BoundingBox::setOrigin(), oofem::MixedGradientPressureNeumann::setPrescribedDeviatoricGradientFromVoigt(), oofem::PrescribedGenStrainShell7::setPrescribedGenStrainShell7Voigt(), oofem::PrescribedGradientHomogenization::setPrescribedGradientVoigt(), oofem::FCMMaterialStatus::setTempCrackStrain(), oofem::TrabBoneMaterialStatus::setTempDepsp(), oofem::TrabBoneMaterialStatus::setTempEpsp(), oofem::FRCFCMNLStatus::setTempFiberStressLoc(), oofem::FRCFCMNLStatus::setTempFiberStressNL(), oofem::FCMMaterialStatus::setTempMaxCrackStrain(), oofem::RCM2MaterialStatus::setTempMaxCrackStrain(), oofem::Shell7Base::setupInitialEdgeSolutionVector(), oofem::Shell7Base::setupInitialSolutionVector(), oofem::LayeredCrossSection::setupLayerMidPlanes(), oofem::GaussIntegrationRule::SetUpPointsOn2DEmbeddedLine(), oofem::GaussIntegrationRule::SetUpPointsOn3dDegShell(), oofem::GaussIntegrationRule::SetUpPointsOn3dDegShellLayers(), oofem::LobattoIntegrationRule::SetUpPointsOnCube(), oofem::GaussIntegrationRule::SetUpPointsOnCube(), oofem::GaussIntegrationRule::SetUpPointsOnCubeLayers(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), oofem::LobattoIntegrationRule::SetUpPointsOnLine(), oofem::GaussIntegrationRule::SetUpPointsOnLine(), oofem::LobattoIntegrationRule::SetUpPointsOnSquare(), oofem::GaussIntegrationRule::SetUpPointsOnSquare(), oofem::GaussIntegrationRule::SetUpPointsOnTetrahedra(), oofem::PatchIntegrationRule::SetUpPointsOnTriangle(), oofem::GaussIntegrationRule::SetUpPointsOnTriangle(), oofem::PatchIntegrationRule::SetUpPointsOnWedge(), oofem::GaussIntegrationRule::SetUpPointsOnWedge(), oofem::LayeredIntegrationRule::SetUpPointsOnWedge(), oofem::GaussIntegrationRule::SetUpPointsOnWedgeLayers(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::FreemInterface::smoothNodalDensities(), oofem::SLEPcSolver::solve(), oofem::DynamicRelaxationSolver::solve(), oofem::GJacobi::solve(), oofem::LineSearchNM::solve(), oofem::SpoolesSolver::solve(), oofem::InverseIteration::solve(), oofem::SubspaceIteration::solve(), oofem::FETISolver::solve(), oofem::StaggeredSolver::solve(), oofem::NRSolver::solve(), oofem::CylindricalALM::solve(), oofem::FloatMatrix::solveForRhs(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::DEIDynamic::solveYourselfAt(), oofem::DIIDynamic::solveYourselfAt(), oofem::NlDEIDynamic::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::CBS::solveYourselfAt(), oofem::NlIsoMoistureMaterial::sorptionIsotherm(), oofem::StructuralMaterial::sortPrincDirAndValCloseTo(), oofem::SpatialLocalizerInterface::SpatialLocalizerI_BBoxContainsPoint(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::PrimaryField::storeDofManager(), oofem::CemhydMat::storeWeightTemperatureProductVolume(), oofem::Concrete2::strsoft(), oofem::StructuralMaterialStatus::StructuralMaterialStatus(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dTetLin::surfaceEvaldNdx(), oofem::FEI3dTetQuad::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEI3dTrLin::surfaceEvaldNdxi(), oofem::FEI3dTrQuad::surfaceEvaldNdxi(), oofem::FEI3dHexaTriQuad::surfaceEvalN(), oofem::FEI3dHexaLin::surfaceEvalN(), oofem::FEI3dTetLin::surfaceEvalN(), oofem::FEI3dWedgeQuad::surfaceEvalN(), oofem::FEI3dTrLin::surfaceEvalN(), oofem::FEI3dTetQuad::surfaceEvalN(), oofem::FEI3dWedgeLin::surfaceEvalN(), oofem::FEI3dTrQuad::surfaceEvalN(), oofem::FEI3dHexaQuad::surfaceEvalN(), oofem::FEI3dHexaTriQuad::surfaceEvalNormal(), oofem::FEI3dHexaLin::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dTetQuad::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceEvalNormal(), oofem::FEI3dTrLin::surfaceGiveJacobianMatrixAt(), oofem::FEI3dTrQuad::surfaceGiveJacobianMatrixAt(), oofem::FEI3dHexaLin::surfaceLocal2global(), oofem::FEI3dTetLin::surfaceLocal2global(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::OctantRec::testBoundingBox(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::testBoundingBox(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::testBoundingSphere(), oofem::SkylineUnsym::times(), oofem::DynCompRow::times(), oofem::DynCompCol::times(), oofem::Skyline::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::SkylineUnsym::timesT(), oofem::DynCompRow::timesT(), oofem::DynCompCol::timesT(), oofem::TrabBoneMaterialStatus::TrabBoneMaterialStatus(), oofem::CompCol_ILUPreconditioner::trans_solve(), oofem::Tr_Warp::transformCoordinates(), oofem::Line::transformIntoPolar(), oofem::MDM::transformStrainToPDC(), oofem::MDM::transformStressFromPDC(), oofem::FETISolver::unpackDirectionVector(), oofem::EngngModel::unpackDofManagers(), oofem::FETISolver::unpackGammas(), oofem::NonLinearDynamic::unpackMigratingData(), oofem::NonLinearStatic::unpackMigratingData(), oofem::FETISolver::unpackPPVector(), oofem::FETISolver::unpackResiduals(), oofem::NodalAveragingRecoveryModel::unpackSharedDofManData(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::SPRNodalRecoveryModel::unpackSharedDofManData(), oofem::Subdivision::unpackSharedIrregulars(), oofem::FETISolver::unpackSolution(), oofem::DofDistributedPrimaryField::update(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::FreeWarping::updateComputedResults(), oofem::RCM2Material::updateCrackStatus(), oofem::FCMMaterial::updateCrackStatus(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::NLTransientTransportProblem::updateDofUnknownsDictionary(), oofem::IncrementalLinearStatic::updateDofUnknownsDictionary(), oofem::PFEM::updateDofUnknownsDictionary(), oofem::SUPG::updateDofUnknownsDictionary_corrector(), 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_SUPG_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::Concrete2::updateStirrups(), oofem::LIBeam3dNL2::updateTempQuaternion(), oofem::LIBeam3dNL::updateTempTriad(), oofem::LIBeam3d2::updateTempTriad(), oofem::FastMarchingMethod::updateTrialValue(), oofem::TR1_2D_SUPG2_AXI::updateVolumePolygons(), oofem::TR1_2D_SUPG2::updateVolumePolygons(), oofem::M4Material::updateVolumetricStressTo(), oofem::AdaptiveNonLinearStatic::updateYourself(), oofem::HydratingConcreteMatStatus::updateYourself(), oofem::Node::updateYourself(), oofem::FCMMaterialStatus::updateYourself(), oofem::Shell7Base::vtkEvalInitialGlobalCoordinateAt(), oofem::Shell7Base::vtkEvalInitialGlobalCZCoordinateAt(), oofem::Shell7Base::vtkEvalUpdatedGlobalCoordinateAt(), oofem::SolutionbasedShapeFunction::whichBoundary(), oofem::VTKXMLExportModule::writeCellVars(), oofem::ErrorCheckingExportModule::writeCheck(), oofem::VTKXMLExportModule::writeExternalForces(), oofem::VTKXMLExportModule::writeIntVars(), oofem::VTKXMLExportModule::writePrimaryVars(), oofem::VTKXMLExportModule::writeVTKCellData(), oofem::VTKXMLExportModule::writeVTKPiece(), oofem::VTKXMLExportModule::writeVTKPointData(), oofem::VTKXMLExportModule::writeXFEMVars(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeDeformationGradientVector(), oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt(), oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule(), oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions(), oofem::TR_SHELL02::ZZErrorEstimatorI_computeLocalStress(), oofem::TR_SHELL01::ZZErrorEstimatorI_computeLocalStress(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().

double oofem::FloatArray::at ( int  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 141 of file floatarray.h.

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 1114 of file floatarray.C.

References oofem::FloatMatrix::copyColumn().

Referenced by oofem::Tr2Shell7XFEM::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::SolidShell::computeBondTransformationMatrix(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Shell7Base::computePressureForceAt(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::Shell7BaseXFEM::computeSectionalForcesAt(), oofem::Shell7Base::computeSectionalForcesAt(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::Shell7Base::CopyIPvaluesToNodes(), oofem::Shell7Base::evalCovarNormalAt(), oofem::Shell7Base::evalInitialCovarNormalAt(), oofem::VTKXMLExportModule::getCellVariableFromIS(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::MITC4Shell::giveDirectorVectors(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::Shell7BaseXFEM::giveFictiousCZNodeCoordsForExport(), oofem::Shell7Base::giveFictiousCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousNodeCoordsForExport(), oofem::Shell7Base::giveFictiousNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedCZNodeCoordsForExport(), oofem::Shell7BaseXFEM::giveFictiousUpdatedNodeCoordsForExport(), oofem::Shell7Base::giveFictiousUpdatedNodeCoordsForExport(), oofem::StructuralMaterial::giveIPValue(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::Structural3DElement::giveMaterialOrientationAt(), oofem::Structural2DElement::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().

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 341 of file floatarray.C.

References FAST_RESIZE, giveSize(), OOFEM_ERROR, and values.

Referenced by oofem::ParticleTopologyDescription::addLineSegment(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::ParticleTopologyDescription::calculateShortestDistance(), oofem::ParticleTopologyDescription::checkOverlap(), oofem::ParticleTopologyDescription::collectNeighbors(), oofem::SolidShell::computeAlpha(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::TrPlanestressRotAllman3d::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLCS(), oofem::BasicGeometry::computeLineDistance(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLocalBaseVectors(), oofem::IntElPoint::computeLocalSlipDir(), oofem::RigidArmNode::computeMasterContribution(), oofem::Quad1PlateSubSoil::computeMidPlaneNormal(), oofem::Tria1PlateSubSoil::computeMidPlaneNormal(), oofem::Quad1Mindlin::computeMidPlaneNormal(), oofem::Quad1MindlinShell3D::computeMidPlaneNormal(), oofem::CCTPlate::computeMidPlaneNormal(), oofem::QDKTPlate::computeMidPlaneNormal(), oofem::DKTPlate::computeMidPlaneNormal(), oofem::PolygonLine::computeNormalSignDist(), oofem::TrabBone3D::computePlasStrainEnerDensity(), oofem::Line::computeProjection(), oofem::TutorialMaterial::computeSphDevPartOf(), oofem::Line::computeTangentialDistanceToEnd(), oofem::IsotropicDamageMaterialStatus::computeWork(), oofem::RankineMatStatus::computeWork_1d(), oofem::RankineMatStatus::computeWork_PlaneStress(), oofem::FEI3dLineLin::evaldNdx(), oofem::ParticleTopologyDescription::findDisplacement(), oofem::PrescribedGradientBCPeriodic::findSlaveToMasterMap(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::ParticleTopologyDescription::generatePSLG(), oofem::PrescribedGradient::give(), oofem::RotatingBoundary::give(), oofem::PrescribedGenStrainShell7::give(), oofem::TransportGradientDirichlet::give(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng_Num(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng_Num(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_Eng_Num(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::IntMatBilinearCZ::giveFirstPKTraction_3d(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::M4Material::giveRealMicroplaneStressVector(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::LinearElasticMaterial::giveRealStressVector_1d(), oofem::LinearElasticMaterial::giveRealStressVector_2dBeamLayer(), oofem::LinearElasticMaterial::giveRealStressVector_3d(), oofem::TutorialMaterial::giveRealStressVector_3d(), oofem::SimpleVitrificationMaterial::giveRealStressVector_3d(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::LinearElasticMaterial::giveRealStressVector_3dDegeneratedShell(), oofem::LinearElasticMaterial::giveRealStressVector_Fiber(), oofem::LinearElasticMaterial::giveRealStressVector_PlaneStrain(), oofem::LinearElasticMaterial::giveRealStressVector_PlaneStress(), oofem::LinearElasticMaterial::giveRealStressVector_PlateLayer(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::PolygonLine::giveTips(), oofem::PrescribedGradientBCWeak::giveTractionElNormal(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::MixedGradientPressureDirichlet::giveUnknown(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dLineLin::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::operator-(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::Triangle::pointIsInTriangle(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::M1MaterialStatus::restoreContext(), oofem::DynamicRelaxationSolver::solve(), oofem::StaggeredSolver::solve(), oofem::NRSolver::solve(), oofem::SUPG::solveYourselfAt(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::FEI3dTetLin::surfaceEvalNormal(), oofem::Line::transformIntoPolar(), oofem::TransientTransportProblem::updateComponent(), oofem::FastMarchingMethod::updateTrialValue(), oofem::DIIDynamic::updateYourself(), and oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule().

void oofem::FloatArray::beDifferenceOf ( const FloatArray a,
const FloatArray b,
int  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 364 of file floatarray.C.

References FAST_RESIZE, giveSize(), and OOFEM_ERROR.

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

Definition at line 93 of file floatarray.h.

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 676 of file floatarray.C.

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

Referenced by oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::ParticleTopologyDescription::calculateShortestDistance(), oofem::ConcreteDPM2::checkForUnAndReloading(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::ParticleTopologyDescription::collectNeighbors(), oofem::ConcreteDPM2::compute3dSecantStiffness(), 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::XfemStructuralElementInterface::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::RCSDEMaterial::computeCurrEquivStrain(), oofem::RCSDMaterial::computeCurrEquivStrain(), oofem::MazarsMaterial::computeDamageParam(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::GradDpElement::computeDeformationGradientVector(), oofem::NLStructuralElement::computeDeformationGradientVector(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::tet21ghostsolid::computeDeformationGradientVectorFromDispl(), oofem::TR1_2D_SUPG_AXI::computeDeviatoricStrain(), oofem::SUPGElement2::computeDeviatoricStrain(), oofem::TR1_2D_SUPG2_AXI::computeDeviatoricStress(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::SUPGElement2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::Shell7BaseXFEM::computeDiscGeneralizedStrainVector(), oofem::XfemElementInterface::computeDisplacementJump(), oofem::MDM::computeEffectiveStress(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::TransportGradientNeumann::computeEta(), oofem::RankineMat::computeEta(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::TransportElement::computeField(), oofem::QTrPlaneStress2dXFEM::computeField(), oofem::TrPlaneStress2dXFEM::computeField(), oofem::PrescribedGradientBCWeak::computeField(), oofem::StructuralElement::computeField(), oofem::TransportElement::computeFlow(), oofem::SolidShell::computeFVector(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::TransportElement::computeInertiaForcesVector(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::TransportElement::computeInternalForcesVector(), oofem::Tr1Darcy::computeInternalForcesVector(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::PolygonLine::computeIntersectionPoints(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::BasicGeometry::computeLineDistance(), oofem::tet21ghostsolid::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::TrPlanestressRotAllman3d::computeLocalNodalCoordinates(), oofem::LinQuad3DPlaneStress::computeLocalNodalCoordinates(), oofem::GradDpElement::computeLocalStrainVector(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::MaterialForceEvaluator::computeMaterialForce(), 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::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::LIBeam3d2::computeStrainVector(), oofem::Quad1MindlinShell3D::computeStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::StructuralElement::computeStrainVector(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::J2plasticMaterial::computeTrialStressIncrement(), oofem::PerfectlyPlasticMaterial::computeTrialStressIncrement(), oofem::MPlasticMaterial::computeTrialStressIncrement(), oofem::MPlasticMaterial2::computeTrialStressIncrement(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::GravityPressure::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::TrabBone3D::constructPlasFlowDirec(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::CrackExportModule::doOutput(), oofem::drawIGAPatchDeformedGeometry(), oofem::Shell7Base::edgeEvalCovarBaseVectorsAt(), oofem::Shell7BaseXFEM::edgeEvalEnrCovarBaseVectorsAt(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncDerivAt(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::TrabBone3D::evaluatePlasCriterion(), oofem::ParticleTopologyDescription::generatePSLG(), oofem::PrescribedGradient::give(), oofem::RotatingBoundary::give(), oofem::PrescribedGenStrainShell7::give(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::TrabBoneNL3D::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::IsoInterfaceDamageMaterial::give3dStiffnessMatrix_Eng(), oofem::IsoInterfaceDamageMaterial_2::give3dStiffnessMatrix_Eng(), oofem::SUPGElement2::giveCharacteristicVector(), oofem::PFEMElement::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::Beam3d::giveCompositeExportData(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::Shell7BaseXFEM::giveDisUnknownsAt(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MPSMaterial::giveEigenStrainVector(), oofem::IsoInterfaceDamageMaterial::giveEngTraction_3d(), oofem::IsoInterfaceDamageMaterial_2::giveEngTraction_3d(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::AnisotropicMassTransferMaterial::giveFluxVector(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam2d(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam3d(), oofem::SimpleCrossSection::giveGeneralizedStress_MembraneRot(), oofem::SimpleCrossSection::giveGeneralizedStress_Plate(), oofem::SimpleCrossSection::giveGeneralizedStress_Shell(), oofem::Element::giveGlobalIPValue(), oofem::SolidShell::giveInternalForcesVector(), oofem::LineDistributedSpring::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::LIBeam3dNL2::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::LIBeam3dNL::giveInternalForcesVector(), oofem::MITC4Shell::giveInternalForcesVector(), oofem::Beam3d::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), 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::tet21ghostsolid::giveIPValue(), oofem::StructuralElement::giveIPValue(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::TrPlaneStrRot3d::giveLocalCoordinates(), oofem::RerShell::giveLocalCoordinates(), oofem::DKTPlate3d::giveLocalCoordinates(), oofem::CCTPlate3d::giveLocalCoordinates(), oofem::MITC4Shell::giveLocalCoordinates(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::MITC4Shell::giveLocalDirectorVectors(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::GradDpElement::giveNonlocalInternalForcesVector(), oofem::RankineMatGrad::givePlaneStressKappaMatrix(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::IsotropicDamageMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::LinearElasticMaterial::giveRealStressVector_1d(), oofem::ConcreteDPM2::giveRealStressVector_1d(), oofem::LinearElasticMaterial::giveRealStressVector_2dBeamLayer(), oofem::WinklerPasternakMaterial::giveRealStressVector_2dPlateSubSoil(), oofem::WinklerMaterial::giveRealStressVector_2dPlateSubSoil(), oofem::LinearElasticMaterial::giveRealStressVector_3d(), oofem::TutorialMaterial::giveRealStressVector_3d(), oofem::SimpleVitrificationMaterial::giveRealStressVector_3d(), oofem::TrabBoneNLEmbed::giveRealStressVector_3d(), oofem::TrabBoneEmbed::giveRealStressVector_3d(), oofem::ConcreteDPM2::giveRealStressVector_3d(), oofem::WinklerMaterial::giveRealStressVector_3dBeamSubSoil(), oofem::LinearElasticMaterial::giveRealStressVector_3dDegeneratedShell(), oofem::LinearElasticMaterial::giveRealStressVector_Fiber(), oofem::LinearElasticMaterial::giveRealStressVector_PlaneStrain(), oofem::LinearElasticMaterial::giveRealStressVector_PlaneStress(), oofem::LinearElasticMaterial::giveRealStressVector_PlateLayer(), oofem::IDGMaterial::giveRealStressVectorGrad(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::OrthotropicLinearElasticMaterial::giveThermalDilatationVector(), 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::TrabBone3D::performPlasticityReturn(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::ConcreteDPM::performRegularReturn(), oofem::FETISolver::projection(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::Shell7BaseXFEM::recoverShearStress(), rotatedWith(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::SubspaceIteration::solve(), oofem::FETISolver::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::Line::transformIntoPolar(), oofem::StructuralMaterial::transformStrainVectorTo(), oofem::StructuralMaterial::transformStressVectorTo(), oofem::StressStrainBaseVector::transformTo(), oofem::Lattice2d_mt::updateInternalState(), oofem::TransportElement::updateInternalState(), oofem::Tet1_3D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::MatrixProductAssembler::vectorFromEdgeLoad(), oofem::LinearizedDilationForceAssembler::vectorFromElement(), oofem::PFEMPressureRhsAssembler::vectorFromElement(), oofem::SUPGInternalForceAssembler::vectorFromElement(), oofem::PFEMCorrectionRhsAssembler::vectorFromElement(), oofem::PFEMLaplaceVelocityAssembler::vectorFromElement(), oofem::PFEMMassVelocityAssembler::vectorFromElement(), oofem::MatrixProductAssembler::vectorFromElement(), oofem::MatrixProductAssembler::vectorFromLoad(), oofem::MatrixProductAssembler::vectorFromSurfaceLoad(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeDeformationGradientVector(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

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 146 of file floatarray.C.

References FAST_RESIZE, and giveSize().

Referenced by add(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::DustMaterial::computePlastStrainDirM1(), oofem::DustMaterial::computePlastStrainDirM2(), oofem::DustMaterial::computePlastStrainDirM3(), oofem::ConstantEdgeLoad::computeValueAt(), oofem::ConstantSurfaceLoad::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::SimpleInterfaceMaterial::giveEngTraction_3d(), oofem::IntMatElastic::giveFirstPKTraction_3d(), oofem::IsotropicMoistureTransferMaterial::giveFluxVector(), oofem::IsotropicHeatTransferMaterial::giveFluxVector(), oofem::NonlinearMassTransferMaterial::giveFluxVector(), oofem::HeMoBazNajMaterial::giveFluxVector(), oofem::HeMoTKMaterial::giveFluxVector(), oofem::LatticeTransportMaterial::giveFluxVector(), oofem::PolygonLine::giveGlobalCoordinates(), oofem::MisesMatNl::giveRealStressVector_1d(), oofem::RankineMatNl::giveRealStressVector_1d(), oofem::RankineMat::giveRealStressVector_1d(), oofem::RankineMatNl::giveRealStressVector_PlaneStress(), oofem::RankineMat::giveRealStressVector_PlaneStress(), oofem::MisesMatGrad::giveRealStressVectorGrad(), oofem::TrabBoneGrad3D::giveRealStressVectorGrad(), oofem::RankineMatGrad::giveRealStressVectorGrad(), oofem::PolygonLine::giveSubPolygon(), oofem::PrescribedGradientBCWeak::giveTractionElArcPos(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), oofem::FEI3dLineLin::local2global(), oofem::operator*(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::Triangle::refineTriangle(), and oofem::NonLinearDynamic::updateComponent().

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 1035 of file floatarray.C.

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

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

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 708 of file floatarray.C.

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

Referenced by oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGenStrainShell7::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::StructuralElement::computePointLoadVectorAt(), oofem::Shell7Base::computePressureForce(), oofem::HTSelement::computePsVectorAt(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::LIBeam3dNL::computeTempCurv(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7Base::computeTractionForce(), oofem::TransportGradientDirichlet::computeXi(), oofem::TrabBone3D::constructAnisoFtensor(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::VTKExportModule::exportPrimVarAs(), oofem::TrabBoneGrad3D::give3dKappaMatrix(), oofem::TrabBoneGrad3D::give3dMaterialStiffnessMatrix(), oofem::TrabBoneNL3D::give3dMaterialStiffnessMatrix(), oofem::TrabBone3D::give3dMaterialStiffnessMatrix(), oofem::IntMatBilinearCZFagerstrom::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZJansson::give3dStiffnessMatrix_dTdj(), oofem::Beam3d::giveCompositeExportData(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::PhaseFieldElement::giveInternalForcesVector_d(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::CoupledFieldsElement::giveInternalForcesVectorGen(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::IDNLMaterial::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_SHELL02::SpatialLocalizerI_giveBBox(), oofem::TR_SHELL01::SpatialLocalizerI_giveBBox(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

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 415 of file floatarray.C.

References at(), FAST_RESIZE, giveSize(), and OOFEM_ERROR.

Referenced by oofem::FloatMatrix::beLocalCoordSys(), oofem::IntElSurfTr1::computeAreaAround(), oofem::Tr2Shell7XFEM::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::MITC4Shell::computeBmatrixAt(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLCS(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::MITC4Shell::computeLocalBaseVectors(), oofem::MITC4Shell::computeLToDirectorRotationMatrix(), oofem::Tria1PlateSubSoil::computeMidPlaneNormal(), oofem::Quad1PlateSubSoil::computeMidPlaneNormal(), oofem::Quad1Mindlin::computeMidPlaneNormal(), oofem::Quad1MindlinShell3D::computeMidPlaneNormal(), oofem::CCTPlate::computeMidPlaneNormal(), oofem::QDKTPlate::computeMidPlaneNormal(), oofem::DKTPlate::computeMidPlaneNormal(), oofem::MITC4Shell::computeNmatrixAt(), oofem::Shell7Base::computePressureForceAt(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::IntElSurfTr1::computeTransformationMatrixAt(), oofem::IntElPoint::computeTransformationMatrixAt(), oofem::GravityPressure::computeValueAt(), oofem::LSpace::drawTriad(), oofem::Shell7Base::edgeEvalCovarBaseVectorsAt(), oofem::Shell7BaseXFEM::edgeEvalEnrCovarBaseVectorsAt(), oofem::Shell7Base::evalCovarNormalAt(), oofem::Shell7Base::evalInitialCovarNormalAt(), oofem::CohesiveSurface3d::evaluateLocalCoordinateSystem(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::FEI3dTrLin::giveArea(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::Structural3DElement::giveMaterialOrientationAt(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::MicroplaneMaterial::initializeData(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::Triangle::pointIsInTriangle(), oofem::FEI3dHexaTriQuad::surfaceEvalNormal(), oofem::FEI3dHexaLin::surfaceEvalNormal(), oofem::FEI3dTetLin::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dTrLin::surfaceEvalNormal(), oofem::FEI3dTetQuad::surfaceEvalNormal(), oofem::FEI3dTrQuad::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceEvalNormal(), oofem::FEI3dTrLin::surfaceGiveJacobianMatrixAt(), and oofem::FEI3dTrQuad::surfaceGiveJacobianMatrixAt().

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 1055 of file floatarray.C.

References at(), and giveSize().

Referenced by oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), and oofem::AbaqusUserMaterial::giveRealStressVector_3d().

void oofem::FloatArray::checkBounds ( int  i) const

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 132 of file floatarray.C.

References giveSize(), and OOFEM_ERROR.

Referenced by isFinite().

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 593 of file floatarray.C.

References giveSize(), oofem::max(), and values.

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 206 of file floatarray.h.

Referenced by oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::EngngModel::assembleVectorFromElements(), oofem::SUPGElement2::computeAdvectionTerm_MB(), oofem::SUPGElement2::computeAdvectionTerm_MC(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::Shell7Base::computeBoundaryEdgeLoadVector(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), oofem::Element::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Element::computeBoundarySurfaceLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::Node2NodeContact::computeContactForces(), oofem::TwoFluidMaterial::computeDeviatoricStressVector(), oofem::SUPGElement2::computeDiffusionTerm_MB(), oofem::SUPGElement2::computeDiffusionTerm_MC(), oofem::Hexa21Stokes::computeExternalForcesVector(), oofem::Tet21Stokes::computeExternalForcesVector(), oofem::Tr21Stokes::computeExternalForcesVector(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::Shell7Base::computeGlobalCoordinates(), oofem::Element::computeGlobalCoordinates(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::TransportElement::computeInternalForcesVector(), oofem::TransportElement::computeInternalSourceRhsSubVectorAt(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::HydratingHeMoMaterial::computeInternalSourceVector(), oofem::HydratingIsoHeatMaterial::computeInternalSourceVector(), oofem::TransportMaterial::computeInternalSourceVector(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::VTKXMLExportModule::computeIPAverage(), oofem::XfemStructuralElementInterface::computeIPAverageInTriangle(), oofem::J2Mat::computeKGradientVector(), oofem::TransportElement::computeLoadVector(), oofem::TR1_2D_SUPG_AXI::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::PFEMElement::computeLoadVector(), oofem::TR1_2D_SUPG::computeLoadVector(), oofem::Node::computeLoadVector(), oofem::Element::computeLoadVector(), oofem::StructuralElement::computeLoadVector(), oofem::DofManager::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::ConstantEdgeLoad::computeNArray(), oofem::ConstantPressureLoad::computeNArray(), oofem::ConstantSurfaceLoad::computeNArray(), oofem::NeumannMomentLoad::computeNArray(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::Shell7BaseXFEM::computeSectionalForcesAt(), oofem::Shell7Base::computeSectionalForcesAt(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::LatticeDamage2d::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), 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::PerfectlyPlasticMaterial::computeTrialStressIncrement(), oofem::ContactElement::ContactElement(), oofem::CylindricalALM::do_lineSearch(), oofem::Node::drawYourself(), oofem::Shell7Base::edgeEvalInitialCovarBaseVectorsAt(), oofem::Shell7Base::edgeEvalInitialDirectorAt(), oofem::FEI3dWedgeQuad::edgeLocal2global(), oofem::FEI3dTetQuad::edgeLocal2global(), oofem::FEI3dWedgeLin::edgeLocal2global(), oofem::FEI3dTrQuad::edgeLocal2global(), oofem::FEI3dHexaQuad::edgeLocal2global(), oofem::Shell7Base::evalInitialDirectorAt(), oofem::VTKExportModule::exportCellVars(), oofem::POIExportModule::exportIntVarAs(), oofem::StructuralElementEvaluator::giveCharacteristicVector(), oofem::Line2BoundaryElement::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::StructuralInterfaceElement::giveCharacteristicVector(), oofem::DummySpatialLocalizer::giveElementClosestToPoint(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::SolidShell::giveInternalForcesVector(), oofem::LumpedMassElement::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::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::LinQuad3DPlaneStress::giveIPValue(), oofem::TrPlanestressRotAllman3d::giveIPValue(), oofem::RVEStokesFlow::giveIPValue(), oofem::Material::giveIPValue(), oofem::Element::giveIPValue(), oofem::MisesMatNl::giveLocalNonlocalStiffnessContribution(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::KelvinChainMaterial::giveShrinkageStrainVector(), oofem::KelvinChainSolidMaterial::giveShrinkageStrainVector(), oofem::MaxwellChainMaterial::giveShrinkageStrainVector(), oofem::RheoChainMaterial::giveShrinkageStrainVector(), oofem::J2MPlasticMaterial::giveStressBackVector(), oofem::J2plasticMaterial::giveStressBackVector(), oofem::J2Mat::giveStressBackVector(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::StructuralMaterial::giveThermalDilatationVector(), oofem::TransportGradientNeumann::initializeFrom(), oofem::StaticStructural::initializeFrom(), oofem::WallClockLoadBalancerMonitor::initializeFrom(), oofem::TransientTransportProblem::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::SparseNonLinearSystemNM::initializeFrom(), oofem::Beam3d::initializeFrom(), oofem::NRSolver::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::MisesMatGradStatus::initTempStatus(), oofem::MisesMatStatus::initTempStatus(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionDev(), oofem::MixedGradientPressureNeumann::integrateVolTangent(), oofem::Quasicontinuum::intersectionTestSegmentSegment2D(), oofem::Quasicontinuum::intersectionTestSegmentTetrahedra3D(), oofem::Quasicontinuum::intersectionTestSegmentTriangle2D(), oofem::Quasicontinuum::intersectionTestSegmentTrianglePlucker3D(), oofem::FEI3dTetLin::local2global(), oofem::FEI3dHexaLin::local2global(), oofem::FEI3dTetQuad::local2global(), oofem::FEI3dTrQuad::local2global(), oofem::FEI3dWedgeLin::local2global(), oofem::FEI3dHexaQuad::local2global(), oofem::Q27Space::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LWedge::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QWedge::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QTRSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Axisymm3d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Wedge_ht::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Truss3d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QWedge_ht::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LTRSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::tet21ghostsolid::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Hexa21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tet21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tr21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::CCTPlate::NodalAveragingRecoveryMI_computeNodalValue(), oofem::DKTPlate::NodalAveragingRecoveryMI_computeNodalValue(), oofem::SlaveNode::postInitialize(), oofem::MixedGradientPressureNeumann::setPrescribedDeviatoricGradientFromVoigt(), oofem::CylindricalALM::solve(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::FEI3dTrQuad::surfaceEvalBaseVectorsAt(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dTetQuad::surfaceLocal2global(), oofem::FEI3dTrQuad::surfaceLocal2global(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::StaticStructural::updateAttributes(), oofem::MisesMatStatus::updateYourself(), oofem::VectorAssembler::vectorFromEdgeLoad(), oofem::LinearizedDilationForceAssembler::vectorFromElement(), oofem::VectorAssembler::vectorFromElement(), oofem::VectorAssembler::vectorFromLoad(), oofem::VectorAssembler::vectorFromNodeLoad(), oofem::VectorAssembler::vectorFromSurfaceLoad(), oofem::Shell7Base::vtkEvalInitialGlobalCoordinateAt(), and oofem::Shell7Base::vtkEvalInitialGlobalCZCoordinateAt().

double oofem::FloatArray::computeNorm ( ) const

Computes the norm (or length) of the vector.

Returns
The Euclidean norm of the vector.

Definition at line 840 of file floatarray.C.

References computeSquaredNorm().

Referenced by oofem::MMALeastSquareProjection::__init(), oofem::ParticleTopologyDescription::addLineSegment(), oofem::ParticleTopologyDescription::checkOverlap(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::IntElSurfTr1::computeAreaAround(), oofem::Tr2Shell7XFEM::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormCompression(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormTension(), oofem::IntMatCoulombContact::computeEngTraction(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::BasicGeometry::computeLineDistance(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::Line::computeTangentialDistanceToEnd(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::ContactElement::ContactElement(), oofem::Shell7Base::edgeComputeLengthAround(), oofem::FEI2dTrQuad::edgeEvaldNds(), oofem::FEI3dTrQuad::edgeGiveTransformationJacobian(), oofem::FEI3dHexaQuad::edgeGiveTransformationJacobian(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::FEI3dTrLin::giveArea(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::ScalarErrorIndicator::giveElementError(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::NonlinearMassTransferMaterial::giveFluxVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEInterpolation2d::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::Node2NodeContact::instanciateYourself(), 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(), oofem::LevelSetPCS::pcs_stage1(), oofem::ConcreteDPM2::performRegularReturn(), oofem::PLMaterialForce::propagateInterface(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::FEI3dTrLin::surfaceEvalNormal(), oofem::FEI3dTrQuad::surfaceEvalNormal(), oofem::Line::transformIntoPolar(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), and oofem::Quad10_2D_SUPG::updateStabilizationCoeffs().

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 864 of file floatarray.C.

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

Referenced by oofem::ActiveDof::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::RVEStokesFlow::giveIPValue(), oofem::FluidDynamicMaterial::giveIPValue(), oofem::ActiveDof::giveUnknowns(), and oofem::SlaveDof::giveUnknowns().

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 489 of file floatarray.C.

References distance_square().

Referenced by oofem::MMAContainingElementProjection::__init(), oofem::MMALeastSquareProjection::__init(), oofem::ArcPosSortFunction3< T >::calcArcPos(), oofem::ArcPosSortFunction4::calcArcPos(), oofem::EnrichmentItem::calcPolarCoord(), oofem::PrescribedGradientBCWeakDirichlet::checkIfCorner(), oofem::PrescribedGradientBCWeakPeriodic::checkIfCorner(), oofem::Line::computeDistanceTo(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::PolygonLine::computeIntersectionPoints(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::LinearEdgeLoad::computeNArray(), oofem::PolygonLine::computeTangentialSignDist(), oofem::MeshQualityErrorEstimator::computeTriangleRadiusError(), oofem::TrabBoneNL::computeWeightFunction(), oofem::TrabBoneNLEmbed::computeWeightFunction(), oofem::MazarsNLMaterial::computeWeightFunction(), oofem::RCSDNLMaterial::computeWeightFunction(), oofem::TrabBoneNL3D::computeWeightFunction(), oofem::MDM::computeWeightFunction(), oofem::NonlocalMaterialExtensionInterface::computeWeightFunction(), oofem::MaterialForceEvaluator::computeWeightFunctionInPoint(), oofem::Shell7Base::CopyIPvaluesToNodes(), oofem::PFEM::deactivateTooCloseParticles(), oofem::LEPlic::doCellDLS(), oofem::ClosestNode::evaluate(), oofem::ElementCircumCirclesContainingNode::evaluate(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncJumps(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncJumps(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncJumps(), oofem::QClinearStatic::findNearestParticle(), oofem::DummySpatialLocalizer::giveAllElementsWithIpWithinBox(), oofem::DummySpatialLocalizer::giveAllNodesWithinBox(), oofem::PolygonLine::giveBoundingSphere(), oofem::FEI3dTetQuad::giveCharacteristicLength(), oofem::FEI3dWedgeLin::giveCharacteristicLength(), oofem::FEI2dQuadQuad::giveCharacteristicLength(), oofem::FEI3dHexaQuad::giveCharacteristicLength(), oofem::DummySpatialLocalizer::giveClosestIP(), oofem::OctreeSpatialLocalizer::giveClosestIP(), oofem::OctreeSpatialLocalizer::giveClosestIPWithinOctant(), oofem::UnstructuredGridField::Cell::giveClosestPoint(), oofem::DelaunayTriangle::giveEdgeLength(), oofem::OctreeSpatialLocalizer::giveElementClosestToPoint(), oofem::OctreeSpatialLocalizer::giveElementsWithIPWithinBox(), oofem::FEI3dLineLin::giveLength(), oofem::DummySpatialLocalizer::giveNodeClosestToPoint(), oofem::OctreeSpatialLocalizer::giveNodesWithinBox(), oofem::Circle::intersects(), oofem::Circle::isInside(), oofem::Delaunay::isInsideCC(), oofem::Circle::isOutside(), oofem::XfemStructureManager::mergeCloseCracks(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), oofem::FreemInterface::smoothNodalDensities(), oofem::SpatialLocalizerInterface::SpatialLocalizerI_giveClosestPoint(), and oofem::FastMarchingMethod::updateTrialValue().

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

Definition at line 391 of file floatarray.h.

References distance().

Referenced by distance().

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 494 of file floatarray.C.

References distance_square().

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.
Todo:
This isn't a distance to "from"?!

Definition at line 536 of file floatarray.C.

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

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 463 of file floatarray.C.

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

Referenced by oofem::ParticleTopologyDescription::addLineSegment(), oofem::FloatMatrix::beLocalCoordSys(), oofem::EnrichmentItem::calcPolarCoord(), oofem::ParticleTopologyDescription::checkOverlap(), oofem::MPlasticMaterial::closestPointReturn(), oofem::ParticleTopologyDescription::collectNeighbors(), oofem::IntElLine1PhF::computeAreaAround(), oofem::IntElLine1PF::computeAreaAround(), oofem::IntElLine1::computeAreaAround(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::EnrichmentFront::computeCrackTangent(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::PhaseFieldElement::computeDamageAt(), oofem::IntElLine1PF::computeDamageAt(), oofem::StructuralInterfaceElementPhF::computeDamageAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::TransportGradientNeumann::computeEta(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::QTruss1dGrad::computeField(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::PhaseFieldElement::computeFreeEnergy(), oofem::IntElLine1PF::computeFreeEnergy(), oofem::Node2NodeContact::computeGap(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::Tr1Darcy::computeInternalForcesVector(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::PolygonLine::computeIntersectionPoints(), oofem::BasicGeometry::computeLineDistance(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLToDirectorRotationMatrix(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::GradDpElement::computeNonlocalCumulatedStrain(), oofem::PolygonLine::computeNormalSignDist(), oofem::TrabBone3D::computePlasStrainEnerDensity(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::Line::computeTangentialDistanceToEnd(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::NeumannMomentLoad::computeValueAtBoundary(), oofem::IsotropicDamageMaterialStatus::computeWork(), oofem::ConcreteDPM2Status::computeWork(), oofem::RankineMatStatus::computeWork_1d(), oofem::RankineMatStatus::computeWork_PlaneStress(), oofem::TransportGradientDirichlet::computeXi(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::TrabBone3D::constructPlasFlowDirec(), oofem::ContactElement::ContactElement(), oofem::dot(), oofem::LSpace::drawTriad(), oofem::EnrFrontIntersection::evaluateEnrFuncAt(), oofem::TrabBone3D::evaluatePlasCriterion(), oofem::ParticleTopologyDescription::generatePSLG(), oofem::TransportGradientDirichlet::give(), oofem::LayeredCrossSection::giveArea(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::LinearElasticMaterial::giveEnergyDensity(), oofem::SimpleInterfaceMaterial::giveEngTraction_3d(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::tet21ghostsolid::giveIPValue(), oofem::Element::giveLengthInDir(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::TrabBoneNLEmbed::giveRealStressVector_3d(), oofem::TrabBoneEmbed::giveRealStressVector_3d(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::SlaveDof::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::SolutionbasedShapeFunction::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::TrabBone3D::projectOnYieldSurface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::FETISolver::solve(), 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().

double oofem::FloatArray::dotProduct ( const FloatArray x,
int  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 476 of file floatarray.C.

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

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

Definition at line 94 of file floatarray.h.

int oofem::FloatArray::giveIndexMaxElem ( void  )
int oofem::FloatArray::giveIndexMinElem ( void  )

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

Definition at line 431 of file floatarray.C.

References giveSize().

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

int oofem::FloatArray::givePackSize ( DataStream buff) const
double* oofem::FloatArray::givePointer ( )
inline

Definition at line 470 of file floatarray.h.

References oofem::operator<<().

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

Returns the size of receiver.

Definition at line 218 of file floatarray.h.

Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::ParallelContext::accumulate(), add(), oofem::ParticleTopologyDescription::addCorner(), oofem::PetscSparseMtrx::addDiagonal(), oofem::SparseMtrx::addDiagonal(), addSubVector(), oofem::FloatMatrix::addSubVectorCol(), oofem::FloatMatrix::addSubVectorRow(), oofem::SymmetryBarrier::applyConstraint(), oofem::SparseNonLinearSystemNM::applyPerturbation(), oofem::LinearConstraintBC::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), assemble(), assembleSquared(), oofem::LinearConstraintBC::assembleVector(), oofem::FloatMatrix::beDiagonal(), beDifferenceOf(), oofem::FloatMatrix::beDyadicProductOf(), oofem::FloatMatrix::beLocalCoordSys(), oofem::FloatMatrix::beMatrixForm(), oofem::FloatMatrix::beMatrixFormOfStress(), beMaxOf(), beMinOf(), oofem::FloatMatrix::beNMatrixOf(), beProductOf(), beScaled(), beSubArrayOf(), beTProductOf(), beVectorProductOf(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::PolylineNonlocalBarrier::calculateMinimumDistanceFromBoundary(), oofem::StructuralPythonMaterial::callStressFunction(), oofem::StructuralPythonMaterial::callTangentFunction(), changeComponentOrder(), oofem::ElementErrorCheckingRule::check(), oofem::BeamElementErrorCheckingRule::check(), checkBounds(), oofem::LumpedMassElement::checkConsistency(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::ConcreteDPM2::checkForUnAndReloading(), oofem::ParticleTopologyDescription::checkOverlap(), checkSizeTowards(), oofem::ConcreteFCM::checkSnapBack(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::ConcreteDPM2::computeAlpha(), oofem::FRCFCMNL::computeAngleBetweenVectors(), oofem::IntElLine1PhF::computeAreaAround(), oofem::IntElLine1::computeAreaAround(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue1D(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::DelaunayTriangulator::computeBBXBasedOnNodeData(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::TR1_2D_PFEM::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::NlIsoMoistureMaterial::computeCapTranspCoeff(), oofem::Triangle::computeCenterOfCircumCircle(), oofem::KelvinChainMaterial::computeCharCoefficients(), oofem::MaxwellChainMaterial::computeCharCoefficients(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::ContactDefinition::computeContactForces(), oofem::Node2NodeContactL::computeContactTangent(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::FRCFCM::computeCrackFibreAngle(), oofem::ConcreteFCM::computeD2ModulusForCrack(), oofem::IntMatIsoDamageTable::computeDamageParam(), oofem::IsoInterfaceDamageMaterial_2::computeDamageParam(), oofem::ConcreteDPM::computeDCosThetaDStress(), oofem::ConcreteDPM::computeDDRhoDDStress(), oofem::ConcreteDPM2::computeDDRhoDDStress(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormCompression(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormTension(), oofem::NewtonianFluidMaterial::computeDeviatoricStressVector(), oofem::NonlinearFluidMaterial::computeDeviatoricStressVector(), oofem::BinghamFluidMaterial2::computeDeviatoricStressVector(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::RheoChainMaterial::computeDiscreteRelaxationFunction(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::ActiveDof::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::ConcreteDPM::computeDuctilityMeasureDamage(), oofem::HeMoKunzelMaterial::computeDw(), oofem::IntMatCoulombContact::computeEngTraction(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IsoInterfaceDamageMaterial::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Line2BoundaryElement::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::Hexa21Stokes::computeField(), oofem::Tr1BubbleStokes::computeField(), oofem::Tr21Stokes::computeField(), oofem::Tet1BubbleStokes::computeField(), oofem::StructuralMaterial::computeFirstInvariant(), oofem::TransportElement::computeFlow(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::PlasticMaterial::ComputeGradientVector(), oofem::MPlasticMaterial::computeGradientVector(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::LIBeam2dNL::computeInitialStressMatrix(), oofem::NLStructuralElement::computeInitialStressMatrix(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::TransportElement::computeInternalSourceRhsVectorAt(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Line::computeIntersectionPoints(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::J2Mat::computeKGradientVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::DofManager::computeM2LTransformation(), 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::ConcreteDPM2::computeRateFactor(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::J2Mat::computeReducedHardeningVarsLamGradient(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::PlasticMaterial::ComputeResidualVector(), oofem::MPlasticMaterial::computeResidualVector(), oofem::MPlasticMaterial2::computeResidualVector(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::B3Material::computeShrinkageStrainVector(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::J2Mat::computeStrainHardeningVarsIncrement(), oofem::LIBeam3d2::computeStrainVector(), oofem::RheoChainMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::LatticeDamage2d::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::StructuralMaterial::computeStressNorm(), oofem::SteelRelaxMat::computeStressRelaxationStrainVector(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVarsReducedGradient(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::LIBeam3dNL::computeTempCurv(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::ConcreteDPM2::computeTrialCoordinates(), oofem::PerfectlyPlasticMaterial::computeTrialStressIncrement(), oofem::RheoChainMaterial::computeTrueStressIndependentStrainVector(), oofem::TF1::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::BoundaryLoad::computeValueAt(), oofem::StructuralMaterial::computeVonMisesStress(), oofem::ConcreteDPM2Status::computeWork(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::ContactElement::ContactElement(), oofem::BoundingBox::contains(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::containsPoint(), oofem::StressStrainBaseVector::convertFromFullForm(), copySubVector(), oofem::FloatMatrix::copySubVectorRow(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), distance_square(), oofem::CylindricalALM::do_lineSearch(), oofem::GPExportModule::doOutput(), oofem::HOMExportModule::doOutput(), oofem::VTKExportModule::doOutput(), oofem::VTKXMLExportModule::doOutput(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::MatlabExportModule::doOutputIntegrationPointFields(), dotProduct(), oofem::Concrete2::dtp2(), oofem::Concrete2::dtp3(), oofem::DarcyFlow::DumpMatricesToFile(), oofem::FEI3dTrLin::edgeLocal2global(), oofem::FEI3dWedgeQuad::edgeLocal2global(), oofem::FEI3dTetQuad::edgeLocal2global(), oofem::FEI3dTrQuad::edgeLocal2global(), oofem::FEI3dWedgeLin::edgeLocal2global(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::tet21ghostsolid::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::Tet21Stokes::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::ScalarFunction::eval(), oofem::CalculatorFunction::evaluate(), oofem::Function::evaluate(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::DofManValueField::evaluateAt(), oofem::UniformGridField::evaluateAt(), oofem::PiecewiseLinFunction::evaluateAtTime(), oofem::PeriodicPiecewiseLinFunction::evaluateAtTime(), oofem::Function::evaluateAtTime(), oofem::Delamination::evaluateEnrFuncAt(), oofem::DamagedNeighborLayered::evaluateFailureCriteria(), oofem::MixedGradientPressureWeakPeriodic::evaluateTractionBasisFunctions(), oofem::PiecewiseLinFunction::evaluateVelocityAtTime(), oofem::PeriodicPiecewiseLinFunction::evaluateVelocityAtTime(), oofem::VTKExportModule::exportCellVars(), oofem::VTKExportModule::exportIntVarAs(), oofem::VTKExportModule::exportPrimVarAs(), oofem::ParticleTopologyDescription::findDisplacement(), oofem::PrescribedGradientBCPeriodic::findSlaveToMasterMap(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::FloatMatrix::FloatMatrix(), oofem::ParticleTopologyDescription::generatePSLG(), oofem::VTKXMLExportModule::getCellVariableFromIS(), oofem::PythonExpression::getDict(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKXMLExportModule::getNodalVariableFromIS(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLExportModule::getNodalVariableFromXFEMST(), oofem::PrescribedGradient::give(), oofem::RotatingBoundary::give(), oofem::PrescribedGenStrainShell7::give(), oofem::UserDefDirichletBC::give(), oofem::TransportGradientDirichlet::give(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give1dStiffnessMatrix_Eng_Num(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give2dStiffnessMatrix_Eng_Num(), oofem::WinklerMaterial::give3dBeamSubSoilStiffMtrx(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_dTdj_Num(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_Eng_Num(), oofem::UnstructuredGridField::Cell::giveBoundingBox(), oofem::HydratingHeMoMaterial::giveCharacteristicValue(), oofem::HydratingIsoHeatMaterial::giveCharacteristicValue(), oofem::OctantRec::giveChildContainingPoint(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::giveChildContainingPoint(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::Node::giveCoordinate(), oofem::ConcreteFCM::giveCrackingModulus(), oofem::TransientTransportProblem::giveDeltaT(), oofem::NonStationaryTransportProblem::giveDeltaT(), oofem::StaggeredProblem::giveDeltaT(), oofem::NonlinearFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::IncrementalLinearStatic::giveDiscreteTime(), oofem::TransientTransportProblem::giveDiscreteTime(), oofem::NonStationaryTransportProblem::giveDiscreteTime(), oofem::StaggeredProblem::giveDiscreteTime(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::Beam3d::giveEndForcesVector(), oofem::StaticStructural::giveEndOfTimeOfInterest(), oofem::IntMatPhaseField::giveEngTraction_3d(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::IntMatBilinearCZElastic::giveFirstPKTraction_3d(), oofem::HeMoBazNajMaterial::giveFluxVector(), oofem::HeMoTKMaterial::giveFluxVector(), oofem::HeMoKunzelMaterial::giveFluxVector(), oofem::RVEStokesFlow::giveFluxVector(), oofem::StructuralMaterial::giveFullSymVectorForm(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam2d(), oofem::SimpleCrossSection::giveGeneralizedStress_Beam3d(), oofem::SimpleCrossSection::giveGeneralizedStress_Plate(), oofem::SimpleCrossSection::giveGeneralizedStress_Shell(), oofem::HeMoTKMaterial::giveHumidity(), oofem::HeMoKunzelMaterial::giveHumidity(), giveIndexMaxElem(), giveIndexMinElem(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_u(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::tet21ghostsolid::giveIPValue(), oofem::Element::giveLengthInDir(), oofem::TrPlaneStrRot3d::giveLocalCoordinates(), oofem::RerShell::giveLocalCoordinates(), oofem::DKTPlate3d::giveLocalCoordinates(), oofem::CCTPlate3d::giveLocalCoordinates(), oofem::MITC4Shell::giveLocalCoordinates(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::LinearConstraintBC::giveLocArray(), oofem::PrescribedGradientBCPeriodic::giveMasterDof(), oofem::NlIsoMoistureMaterial::giveMoistureCapacity(), oofem::StaticStructural::giveNextStep(), oofem::NodalRecoveryModel::giveNodalVector(), oofem::ConcreteFCM::giveNormalCrackingStress(), givePackSize(), oofem::NlIsoMoistureMaterial::givePermeability(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::IsotropicDamageMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::M1Material::giveRealStressVector_3d(), oofem::StructuralFE2Material::giveRealStressVector_3d(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::StructuralMaterial::giveReducedSymVectorForm(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::Shell7Base::giveShellExportData(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::LayeredCrossSection::giveSlaveGaussPoint(), oofem::StructuralMaterial::giveStressDependentPartOfStrainVector(), oofem::StructuralMaterial::giveStressDependentPartOfStrainVector_3d(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::MixedGradientPressureDirichlet::giveUnknown(), oofem::tet21ghostsolid::giveUnknownData(), oofem::ActiveDof::giveUnknowns(), oofem::SlaveDof::giveUnknowns(), oofem::Node::giveUpdatedCoordinates(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEI3dHexaQuad::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::SolutionbasedShapeFunction::init(), oofem::MazarsMaterial::initDamaged(), oofem::ConcreteDPM2::initDamaged(), oofem::FloatMatrix::initFromVector(), oofem::SlaveDof::initialize(), oofem::LevelSetPCS::initialize(), oofem::QCFullsolveddomain::initializeFrom(), oofem::SlaveNode::initializeFrom(), oofem::LineDistributedSpring::initializeFrom(), oofem::SymmetryBarrier::initializeFrom(), oofem::AnisotropicLinearElasticMaterial::initializeFrom(), oofem::IncrementalLinearStatic::initializeFrom(), oofem::StaticStructural::initializeFrom(), oofem::WallClockLoadBalancerMonitor::initializeFrom(), oofem::LinearConstraintBC::initializeFrom(), oofem::NodalSpringElement::initializeFrom(), oofem::ConcreteFCM::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::FRCFCM::initializeFrom(), oofem::HeMoKunzelMaterial::initializeFrom(), oofem::CemhydMat::initializeFrom(), oofem::BSplineInterpolation::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::CompoDamageMat::initializeFrom(), oofem::SparseNonLinearSystemNM::initializeFrom(), oofem::LevelSetPCS::initializeFrom(), oofem::NlIsoMoistureMaterial::initializeFrom(), oofem::FiberedCrossSection::initializeFrom(), oofem::NRSolver::initializeFrom(), oofem::Load::initializeFrom(), oofem::Node::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::PolygonLine::initializeFrom(), oofem::QClinearStatic::initializeFullSolvedDomain(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::UnstructuredGridField::initOctree(), oofem::MisesMatGradStatus::initTempStatus(), oofem::RankineMatGradStatus::initTempStatus(), oofem::PlasticMaterialStatus::initTempStatus(), oofem::RCSDNLMaterialStatus::initTempStatus(), oofem::PerfectlyPlasticMaterialStatus::initTempStatus(), oofem::MPlasticMaterialStatus::initTempStatus(), oofem::StructuralMaterialStatus::initTempStatus(), oofem::MPlasticMaterial2Status::initTempStatus(), oofem::Concrete2MaterialStatus::initTempStatus(), oofem::RankineMatStatus::initTempStatus(), oofem::OctreeSpatialLocalizer::insertElementIntoOctree(), oofem::HybridEI::interpGradLevelSet(), oofem::HybridEI::interpLevelSet(), oofem::HybridEI::interpLevelSetTangential(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::MMAShapeFunctProjection::interpolateIntVarAt(), isFinite(), oofem::QCFullsolveddomain::isNodeInside(), oofem::FEI3dTetQuad::local2global(), oofem::FEI2dQuadQuad::local2global(), oofem::FEI3dHexaQuad::local2global(), oofem::ParallelContext::localDotProduct(), oofem::ParallelContext::localNorm(), oofem::ls2fit(), oofem::VTKXMLExportModule::makeFullTensorForm(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::TriangleMesherInterface::meshPSLG(), oofem::MDM::MMI_map(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QClinearStatic::nodeInFullSolvedDomainTest(), oofem::UniformGridField::nodeValue2d(), oofem::UniformGridField::nodeValue3d(), oofem::AnisotropicDamageMaterial::obtainAlpha1(), oofem::AnisotropicDamageMaterial::obtainAlpha2(), oofem::operator<<(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputGradient(), oofem::GnuplotExportModule::outputXFEM(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::MisesMat::performPlasticityReturn(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::ConcreteDPM2::performRegularReturn(), oofem::ConcreteDPM::performVertexReturn(), oofem::ConcreteDPM2::performVertexReturn(), oofem::FloatMatrix::plusDyadSymmUpper(), oofem::FloatMatrix::plusDyadUnsym(), plusProduct(), oofem::Triangle::pointIsInTriangle(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::IntMatCoulombContactStatus::printOutputAt(), oofem::PlasticMaterialStatus::printOutputAt(), oofem::M1MaterialStatus::printOutputAt(), oofem::MPlasticMaterialStatus::printOutputAt(), oofem::NodalSpringElement::printOutputAt(), oofem::LineDistributedSpring::printOutputAt(), oofem::MPlasticMaterial2Status::printOutputAt(), oofem::NRSolver::printState(), oofem::DynCompRow::printStatistics(), oofem::LayeredCrossSection::printYourself(), printYourself(), printYourselfToFile(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLCrackPrescribedDir::propagateInterface(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), oofem::M1MaterialStatus::restoreContext(), oofem::PetscSparseMtrx::scatterL2G(), oofem::FloatMatrix::setColumn(), oofem::UniformGridField::setGeometry(), oofem::BoundingBox::setOrigin(), oofem::PrescribedGenStrainShell7::setPrescribedGenStrainShell7Voigt(), oofem::PrescribedGradientHomogenization::setPrescribedGradientVoigt(), oofem::GaussIntegrationRule::SetUpPointsOn3dDegShellLayers(), oofem::GaussIntegrationRule::SetUpPointsOnCubeLayers(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), oofem::GaussIntegrationRule::SetUpPointsOnWedgeLayers(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::UniformGridField::setValues(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::DiagPreconditioner::solve(), oofem::PetscSolver::solve(), oofem::MKLPardisoSolver::solve(), oofem::DynamicRelaxationSolver::solve(), oofem::PardisoProjectOrgSolver::solve(), oofem::CompCol_ILUPreconditioner::solve(), oofem::SuperLUSolver::solve(), oofem::LineSearchNM::solve(), oofem::SpoolesSolver::solve(), oofem::IMLSolver::solve(), oofem::FETISolver::solve(), oofem::StaggeredSolver::solve(), oofem::NRSolver::solve(), oofem::CylindricalALM::solve(), oofem::FloatMatrix::solveForRhs(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::NlIsoMoistureMaterial::sorptionIsotherm(), oofem::StructuralMaterial::sortPrincDirAndValCloseTo(), oofem::SpatialLocalizerInterface::SpatialLocalizerI_BBoxContainsPoint(), oofem::Quasicontinuum::stiffnessAssignment(), storeYourself(), oofem::StressStrainBaseVector::StressStrainBaseVector(), subtract(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dTrLin::surfaceLocal2global(), oofem::FEI3dTetQuad::surfaceLocal2global(), oofem::FEI3dTrQuad::surfaceLocal2global(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::OctantRec::testBoundingBox(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::testBoundingSphere(), oofem::PetscSparseMtrx::times(), oofem::SkylineUnsym::times(), oofem::DynCompRow::times(), oofem::DynCompCol::times(), oofem::Skyline::times(), oofem::SymCompCol::times(), oofem::CompCol::times(), oofem::PetscSparseMtrx::timesT(), oofem::SkylineUnsym::timesT(), oofem::DynCompRow::timesT(), oofem::DynCompCol::timesT(), oofem::CompCol::timesT(), oofem::DiagPreconditioner::trans_solve(), oofem::CompCol_ILUPreconditioner::trans_solve(), oofem::StaticStructural::updateAttributes(), oofem::TransientTransportProblem::updateComponent(), oofem::FreeWarping::updateComputedResults(), oofem::FCMMaterial::updateCrackStatus(), oofem::PFEM::updateDofUnknownsDictionary(), oofem::PFEM::updateDofUnknownsDictionaryVelocities(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydrationModel::updateInternalState(), oofem::Shell7Base::updateLayerTransvShearStressesSR(), oofem::Shell7Base::updateLayerTransvStressesSR(), oofem::FCMMaterialStatus::updateYourself(), oofem::ParticleTopologyDescription::updateYourself(), oofem::LinearizedDilationForceAssembler::vectorFromElement(), oofem::SolutionbasedShapeFunction::whichBoundary(), oofem::ErrorCheckingExportModule::writeCheck(), oofem::ParticleTopologyDescription::writeDataToFile(), oofem::VTKXMLExportModule::writeIntVars(), oofem::VTKXMLExportModule::writeVTKCellData(), oofem::ParticleTopologyDescription::writeVTKFile(), oofem::VTKXMLExportModule::writeVTKPiece(), oofem::VTKXMLExportModule::writeVTKPointData(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), oofem::UniformGridField::xyz2ijk(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

void oofem::FloatArray::hardResize ( int  s)

Resizes the size of the receiver to requested bounds.

Memory allocation always happens, more preferably use resize() function instead. Array is zeroed.

Parameters
sNew size.

Definition at line 639 of file floatarray.C.

References values.

bool oofem::FloatArray::isEmpty ( ) const
inline

Returns true if receiver is empty.

Definition at line 222 of file floatarray.h.

Referenced by add(), oofem::TR_SHELL01::computeBodyLoadVectorAt(), oofem::HeMoTKMaterial::computeCapacityCoeff(), oofem::HeMoKunzelMaterial::computeCapacityCoeff(), oofem::MazarsMaterial::computeDamageParam(), oofem::MazarsMaterial::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::AnisotropicDamageMaterial::computeEquivalentStrain(), oofem::LatticeDamage2d::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::TransportElement::computeInternalSourceRhsVectorAt(), oofem::J2MPlasticMaterial::computeJ2InvariantAt(), oofem::J2Mat::computeJ2InvariantAt(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::HydrationModel::giveCharacteristicValue(), oofem::TR_SHELL02::giveCharacteristicVector(), oofem::TR_SHELL01::giveCharacteristicVector(), oofem::KelvinChainSolidMaterial::giveEigenStrainVector(), oofem::KelvinChainSolidMaterial::giveEModulus(), oofem::HeMoBazNajMaterial::giveFluxVector(), oofem::IsotropicHeatTransferMaterial::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::LinearEdgeLoad::initializeFrom(), oofem::HeMoBazNajMaterial::matcond1d(), oofem::HeMoTKMaterial::matcond1d(), oofem::HeMoKunzelMaterial::matcond1d(), oofem::HeMoBazNajMaterial::matcond2d(), oofem::HeMoTKMaterial::matcond2d(), oofem::HeMoKunzelMaterial::matcond2d(), oofem::HeMoBazNajMaterial::matcond3d(), oofem::HeMoTKMaterial::matcond3d(), oofem::HeMoKunzelMaterial::matcond3d(), oofem::NonLinearStatic::packMigratingData(), plusProduct(), subtract(), oofem::B3SolidMaterial::updateEparModuli(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), and oofem::AdaptiveNonLinearStatic::updateYourself().

bool oofem::FloatArray::isFinite ( ) const

Returns true if no element is NAN or infinite.

Definition at line 72 of file floatarray.C.

References at(), checkBounds(), giveSize(), OOFEM_ERROR, operator()(), operator[](), and values.

Referenced by oofem::LSPrimaryVariableMapper::mapPrimaryVariables().

void oofem::FloatArray::negated ( )

Switches the sign of every coefficient of receiver.

Returns
receiver.

Definition at line 739 of file floatarray.C.

Referenced by oofem::StokesFlowVelocityHomogenization::applyPressureGradient(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::NonStationaryTransportProblem::assembleDirichletBcRhsVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::ContactDefinition::computeContactForces(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::TransportElement::computeFlow(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::CBSElement::computePrescribedTermsI(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::LEPlic::doCellDLS(), oofem::AnisotropicMassTransferMaterial::giveFluxVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::ConcreteDPM::performRegularReturn(), oofem::NonLinearStatic::proceedStep(), oofem::FETISolver::solve(), oofem::StaticStructural::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), and oofem::PFEMPressureRhsAssembler::vectorFromElement().

double oofem::FloatArray::normalize ( )

Normalizes receiver.

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

Returns
modified receiver

Definition at line 828 of file floatarray.C.

References computeNorm(), oofem::norm(), OOFEM_ERROR, and times().

Referenced by oofem::FloatMatrix::beLocalCoordSys(), oofem::ParticleTopologyDescription::calculateShortestDistance(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::LinQuad3DPlaneStress::computeGtoLRotationMatrix(), oofem::InterfaceElem2dLin::computeGtoLRotationMatrix(), oofem::InterfaceElem2dQuad::computeGtoLRotationMatrix(), oofem::TrPlaneStrRot3d::computeGtoLRotationMatrix(), oofem::CCTPlate3d::computeGtoLRotationMatrix(), oofem::DKTPlate3d::computeGtoLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLCS(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::MITC4Shell::computeLocalBaseVectors(), oofem::InterfaceElem1d::computeLocalSlipDir(), oofem::IntElPoint::computeLocalSlipDir(), oofem::Quad1PlateSubSoil::computeMidPlaneNormal(), oofem::Tria1PlateSubSoil::computeMidPlaneNormal(), oofem::Quad1Mindlin::computeMidPlaneNormal(), oofem::Quad1MindlinShell3D::computeMidPlaneNormal(), oofem::CCTPlate::computeMidPlaneNormal(), oofem::QDKTPlate::computeMidPlaneNormal(), oofem::DKTPlate::computeMidPlaneNormal(), oofem::PolygonLine::computeNormalSignDist(), oofem::IntElSurfTr1::computeTransformationMatrixAt(), oofem::IntElLine1PF::computeTransformationMatrixAt(), oofem::IntElLine1PhF::computeTransformationMatrixAt(), oofem::IntElLine1::computeTransformationMatrixAt(), oofem::IntElPoint::computeTransformationMatrixAt(), oofem::GravityPressure::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::LEPlic::doCellDLS(), oofem::LSpace::drawTriad(), oofem::Shell7Base::edgeEvalCovarBaseVectorsAt(), oofem::Shell7BaseXFEM::edgeEvalEnrCovarBaseVectorsAt(), oofem::FEI2dQuadLin::edgeEvalNormal(), oofem::FEI2dTrQuad::edgeEvalNormal(), oofem::FEI2dTrLin::edgeEvalNormal(), oofem::FEI2dLineHermite::edgeEvalNormal(), oofem::FEI2dLineQuad::edgeEvalNormal(), oofem::FEI2dLineLin::edgeEvalNormal(), oofem::FEI2dQuadQuad::edgeEvalNormal(), oofem::Shell7Base::evalCovarNormalAt(), oofem::FEI2dLineHermite::evaldNdx(), oofem::Shell7Base::evalInitialCovarNormalAt(), oofem::CohesiveSurface3d::evaluateLocalCoordinateSystem(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::Lattice2d::giveCrossSectionCoordinates(), oofem::Lattice2d_mt::giveCrossSectionCoordinates(), oofem::MITC4Shell::giveDirectorVectors(), oofem::Truss3d::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::Structural3DElement::giveMaterialOrientationAt(), oofem::Structural2DElement::giveMaterialOrientationAt(), oofem::PrescribedGradientBCWeak::giveMirroredPointOnGammaMinus(), oofem::PrescribedGradientBCWeak::giveMirroredPointOnGammaPlus(), oofem::PolygonLine::giveNormal(), oofem::PolygonLine::giveTangent(), oofem::PolygonLine::giveTips(), oofem::PrescribedGradientBCWeak::giveTractionElNormal(), oofem::RotatingBoundary::initializeFrom(), oofem::SpringElement::initializeFrom(), oofem::PrescribedGradientBCWeak::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::NCPrincipalStrain::nucleateEnrichmentItems(), oofem::NCPrincipalStress::nucleateEnrichmentItems(), oofem::Triangle::pointIsInTriangle(), oofem::PLMaterialForce::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::ParticleTopologyDescription::shortestDistanceFromCurve(), oofem::FEI3dHexaTriQuad::surfaceEvalNormal(), oofem::FEI3dHexaLin::surfaceEvalNormal(), oofem::FEI3dTetLin::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dTetQuad::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceEvalNormal(), oofem::FastMarchingMethod::updateTrialValue(), and oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule().

double& oofem::FloatArray::operator() ( int  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 153 of file floatarray.h.

Referenced by isFinite().

const double& oofem::FloatArray::operator() ( int  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 169 of file floatarray.h.

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

Assignment operator.

Definition at line 111 of file floatarray.h.

References values.

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

Move operator.

Definition at line 113 of file floatarray.h.

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

Assignment operator.

Definition at line 115 of file floatarray.h.

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

Assignment of scalar to all components of receiver.

Definition at line 928 of file floatarray.C.

References begin().

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

Definition at line 156 of file floatarray.h.

Referenced by isFinite().

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

Definition at line 170 of file floatarray.h.

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 226 of file floatarray.C.

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

Referenced by oofem::SUPGElement2::computeAdvectionTerm_MB(), oofem::SUPGElement2::computeAdvectionTerm_MC(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::SUPGElement2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::TransportElement::computeInternalForcesVector(), oofem::Tr1Darcy::computeInternalForcesVector(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::TransportElement::computeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computeSectionalForces(), oofem::Shell7BaseXFEM::computeSectionalForcesAt(), oofem::Shell7Base::computeSectionalForcesAt(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::Shell7Base::computeTractionForce(), oofem::SolidShell::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::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::GradDpElement::giveLocalInternalForcesVector(), oofem::MisesMatNl::giveLocalNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionDev(), oofem::MixedGradientPressureNeumann::integrateVolTangent(), and oofem::LinearizedDilationForceAssembler::vectorFromElement().

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

Raise each element to its power.

Parameters
exponentAn exponent.

Definition at line 1105 of file floatarray.C.

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

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 759 of file floatarray.C.

References giveSize().

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 770 of file floatarray.C.

References giveSize(), and OOFEM_ERROR.

double oofem::FloatArray::product ( ) const

Computes the product of receiver values.

Returns
Product of receiver.

Definition at line 858 of file floatarray.C.

References begin(), and end().

Referenced by oofem::StokesFlowVelocityHomogenization::giveAreaOfRVE().

void oofem::FloatArray::pY ( ) const
virtual
void oofem::FloatArray::reserve ( int  s)

Allocates enough size to fit s, and clears the array.

Parameters
sNew reserved size.

Definition at line 608 of file floatarray.C.

References values.

Referenced by oofem::Element::computeBoundaryVectorOf(), oofem::Element::computeVectorOf(), and oofem::Element::computeVectorOfPrescribed().

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

Resizes receiver towards requested size.

Array is zeroed.

Parameters
sNew size.
Todo:
Change to this (faster)

Definition at line 631 of file floatarray.C.

References values.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMALeastSquareProjection::__mapVariable(), oofem::AbaqusUserMaterialStatus::AbaqusUserMaterialStatus(), oofem::ParallelContext::accumulate(), oofem::AdaptiveNonLinearStatic::adaptiveRemap(), oofem::Quasicontinuum::applyApproach3(), oofem::StructuralMaterial::applyDeviatoricElasticCompliance(), oofem::StructuralMaterial::applyDeviatoricElasticStiffness(), oofem::StructuralMaterial::applyElasticCompliance(), oofem::StructuralMaterial::applyElasticStiffness(), oofem::SUPG::applyIC(), oofem::NonStationaryTransportProblem::applyIC(), oofem::CBS::applyIC(), oofem::PFEM::applyIC(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::NonLinearStatic::assembleIncrementalReferenceLoadVectors(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::DIIDynamic::assembleLoadVector(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::EngngModel::assembleVector(), oofem::BSplineInterpolation::basisFuns(), oofem::FloatMatrix::beMatrixFormOfStress(), oofem::BinghamFluidMaterial2Status::BinghamFluidMaterial2Status(), oofem::FEInterpolation1d::boundaryEvalN(), oofem::SymCompCol::buildInternalStructure(), oofem::CompCol::buildInternalStructure(), oofem::StructuralPythonMaterial::callStressFunction(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::CompoDamageMatStatus::CompoDamageMatStatus(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MC(), oofem::MPSMaterial::computeB4AutogenousShrinkageStrainVector(), oofem::Triangle::computeBarycentrCoor(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue1D(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubVectorAt(), oofem::TransportElement::computeBCVectorAt(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::TransportElement::computeBodyBCSubVectorAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::TR_SHELL01::computeBodyLoadVectorAt(), oofem::TR1_2D_PFEM::computeBodyLoadVectorAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Triangle::computeCenterOfCircumCircle(), oofem::FreeWarping::computeCenterOfGravity(), oofem::B3SolidMaterial::computeCharCoefficients(), oofem::Eurocode2CreepMaterial::computeCharCoefficients(), oofem::MPSMaterial::computeCharCoefficients(), oofem::B3SolidMaterial::computeCharTimes(), oofem::Eurocode2CreepMaterial::computeCharTimes(), oofem::RheoChainMaterial::computeCharTimes(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::Node2NodeContactL::computeContactForces(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::TR1_2D_CBS::computeCorrectionRhs(), oofem::IntElLine1IntPen::computeCovarBaseVectorAt(), oofem::IntElLine2IntPen::computeCovarBaseVectorAt(), oofem::IntElLine1PF::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorAt(), oofem::IntElLine1::computeCovarBaseVectorAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::ConcreteDPM2::computeDamage(), oofem::MazarsMaterial::computeDamageParam(), oofem::ConcreteDPM2::computeDDKappaDDeltaLambdaDInv(), oofem::TrabBone3D::computeDensificationStress(), oofem::TR1_2D_CBS::computeDensityRhsPressureTerms(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::TR1_2D_SUPG::computeDeviatoricStrain(), oofem::TR1_2D_SUPG2_AXI::computeDeviatoricStress(), oofem::TR1_2D_PFEM::computeDeviatoricStress(), oofem::TR1_2D_SUPG2::computeDeviatoricStress(), oofem::TR1_2D_PFEM::computeDeviatoricStressDivergence(), oofem::NewtonianFluidMaterial::computeDeviatoricStressVector(), oofem::BinghamFluidMaterial2::computeDeviatoricStressVector(), oofem::ConcreteDPM2::computeDFDInv(), oofem::TR1_2D_CBS::computeDiagonalMassMtrx(), oofem::TR1_2D_PFEM::computeDiagonalMassMtrx(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::RheoChainMaterial::computeDiscreteRelaxationFunction(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::XfemElementInterface::computeDisplacementJump(), oofem::ActiveDof::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::Dof::computeDofTransformation(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::FRCFCMNL::computeElementCentroid(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::MazarsMaterial::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::StructuralEngngModel::computeExternalLoadReactionContribution(), oofem::MPSMaterial::computeFibAutogenousShrinkageStrainVector(), oofem::Line2BoundaryElement::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::Hexa21Stokes::computeField(), oofem::Tr1BubbleStokes::computeField(), oofem::Tr21Stokes::computeField(), oofem::Tet1BubbleStokes::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::Tr_Warp::computeFirstMomentOfArea(), oofem::TransportElement::computeFlow(), oofem::IntElSurfTr1::computeGlobalCoordinates(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::InterfaceElement3dTrLin::computeGlobalCoordinates(), oofem::LIBeam2dNL::computeGlobalCoordinates(), oofem::Lattice2d::computeGlobalCoordinates(), oofem::LIBeam2d::computeGlobalCoordinates(), oofem::LIBeam3d::computeGlobalCoordinates(), oofem::Truss2d::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::LIBeam3dNL2::computeGlobalCoordinates(), oofem::LIBeam3dNL::computeGlobalCoordinates(), oofem::Lattice2d_mt::computeGlobalCoordinates(), oofem::LIBeam3d2::computeGlobalCoordinates(), oofem::Beam3d::computeGlobalCoordinates(), oofem::CCTPlate3d::computeGlobalCoordinates(), oofem::DKTPlate3d::computeGlobalCoordinates(), oofem::MITC4Shell::computeGlobalCoordinates(), oofem::MPlasticMaterial::computeGradientVector(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::Eurocode2CreepMaterial::computeIncrementOfAutogenousShrinkageVector(), oofem::Eurocode2CreepMaterial::computeIncrementOfDryingShrinkageVector(), oofem::AnisotropicDamageMaterial::computeInplaneStress(), oofem::Tr1Darcy::computeInternalForcesVector(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::TransportElement::computeInternalSourceRhsVectorAt(), oofem::HydratingConcreteMat::computeInternalSourceVector(), oofem::CemhydMat::computeInternalSourceVector(), oofem::HydrationModel::computeInternalSourceVector(), oofem::TR21_2D_SUPG::computeIntersection(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::J2Mat::computeKGradientVector(), oofem::Masonry02::computeKGradientVector(), oofem::DruckerPragerCutMat::computeKGradientVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::TR1_2D_SUPG_AXI::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::PFEMElement::computeLoadVector(), oofem::TR1_2D_SUPG::computeLoadVector(), oofem::NlDEIDynamic::computeLoadVector(), oofem::DofManager::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::RerShell::computeLocalCoordinates(), oofem::Lattice2d_mt::computeLocalCoordinates(), oofem::CCTPlate3d::computeLocalCoordinates(), oofem::DKTPlate3d::computeLocalCoordinates(), oofem::MITC4Shell::computeLocalCoordinates(), oofem::TrPlanestressRotAllman::computeLocalNodalCoordinates(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::NlDEIDynamic::computeMassMtrx(), 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::MPSMaterial::computePointShrinkageStrainVector(), oofem::SPRNodalRecoveryModel::computePolynomialTerms(), oofem::MMALeastSquareProjection::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::LIBeam3dNL2::computeQuaternionFromRotMtrx(), oofem::StructuralEngngModel::computeReaction(), oofem::MPlasticMaterial::computeResidualVector(), oofem::MPlasticMaterial2::computeResidualVector(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::Shell7Base::computeSectionalForces(), oofem::DKTPlate::computeShearForces(), oofem::B3Material::computeShrinkageStrainVector(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::J2Mat::computeStrainHardeningVarsIncrement(), oofem::Masonry02::computeStrainHardeningVarsIncrement(), oofem::DruckerPragerCutMat::computeStrainHardeningVarsIncrement(), oofem::LIBeam3dNL::computeStrainVector(), oofem::LIBeam3dNL2::computeStrainVector(), oofem::HTSelement::computeStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::StructuralElement::computeStrainVector(), oofem::MicroplaneMaterial::computeStrainVectorComponents(), oofem::LIBeam2d::computeStrainVectorInLayer(), oofem::LIBeam2dNL::computeStrainVectorInLayer(), oofem::RerShell::computeStrainVectorInLayer(), oofem::TrPlanestressRotAllman::computeStrainVectorInLayer(), oofem::CCTPlate::computeStrainVectorInLayer(), oofem::QDKTPlate::computeStrainVectorInLayer(), oofem::Beam2d::computeStrainVectorInLayer(), oofem::DKTPlate::computeStrainVectorInLayer(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::J2MPlasticMaterial::computeStressGradientVector(), oofem::RankinePlasticMaterial::computeStressGradientVector(), oofem::J2Mat::computeStressGradientVector(), oofem::DruckerPragerCutMat::computeStressGradientVector(), oofem::Masonry02::computeStressGradientVector(), oofem::LatticeDamage2d::computeStressIndependentStrainVector(), oofem::SteelRelaxMat::computeStressRelaxationStrainVector(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::HTSelement::computeStressVector(), oofem::LineDistributedSpring::computeStressVector(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::HTSelement::computeSvMatrixAt(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::B3Material::computeTotalAverageShrinkageStrainVector(), oofem::B3SolidMaterial::computeTotalAverageShrinkageStrainVector(), oofem::Shell7Base::computeTractionForce(), oofem::HTSelement::computeUvMatrixAt(), oofem::TF1::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::UserDefinedTemperatureField::computeValueAt(), oofem::BoundaryLoad::computeValueAt(), oofem::Load::computeValues(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::NeumannMomentLoad::computeXbar(), oofem::LIBeam3dNL::computeXdVector(), oofem::LIBeam3dNL2::computeXdVector(), oofem::TransportGradientDirichlet::computeXi(), oofem::ConcreteDPM2Status::ConcreteDPM2Status(), oofem::ConcreteDPMStatus::ConcreteDPMStatus(), oofem::StructuralElement::condense(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::ContactElement::ContactElement(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::CylindricalALM::convertHPCMap(), oofem::SparseNonLinearSystemNM::convertPertMap(), oofem::StressStrainBaseVector::convertToFullForm(), oofem::FloatMatrix::copyColumn(), oofem::StructuralFE2MaterialStatus::copyStateVariables(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::TSplineInterpolation::dersBasisFunction(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::GPInitModule::doInit(), oofem::drawIGAPatchDeformedGeometry(), oofem::IGAElement::drawRawGeometry(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::PlaneStress2d::drawSpecial(), oofem::Quad1PlaneStrain::drawSpecial(), oofem::DruckerPragerPlasticitySMStatus::DruckerPragerPlasticitySMStatus(), oofem::DustMaterialStatus::DustMaterialStatus(), oofem::FEI2dLineHermite::edgeEvald2Nds2(), oofem::FEI2dLineHermite::edgeEvaldNds(), oofem::FEI2dLineLin::edgeEvaldNds(), oofem::FEI2dLineQuad::edgeEvaldNds(), oofem::FEI3dHexaLin::edgeEvaldNdxi(), oofem::FEI3dTrLin::edgeEvaldNdxi(), oofem::FEI3dTrQuad::edgeEvaldNdxi(), oofem::FEI3dHexaLin::edgeEvalN(), oofem::FEI2dTrConst::edgeEvalN(), oofem::FEI3dTetLin::edgeEvalN(), oofem::FEI3dTrLin::edgeEvalN(), oofem::FEI3dWedgeQuad::edgeEvalN(), oofem::FEI3dTrQuad::edgeEvalN(), oofem::FEI3dTetQuad::edgeEvalN(), oofem::FEI3dWedgeLin::edgeEvalN(), oofem::FEI3dHexaQuad::edgeEvalN(), oofem::FEI2dTrQuad::edgeEvalNormal(), oofem::FEI2dLineHermite::edgeEvalNormal(), oofem::FEI2dLineLin::edgeEvalNormal(), oofem::FEI2dLineQuad::edgeEvalNormal(), oofem::FEI2dQuadQuad::edgeEvalNormal(), oofem::FEI3dHexaLin::edgeLocal2global(), oofem::FEI3dTetLin::edgeLocal2global(), oofem::FEI2dTrConst::edgeLocal2global(), oofem::FEI3dTrLin::edgeLocal2global(), oofem::FEI2dQuadLin::edgeLocal2global(), oofem::FEI2dTrQuad::edgeLocal2global(), oofem::FEI2dTrLin::edgeLocal2global(), oofem::FEI2dQuadQuad::edgeLocal2global(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::tet21ghostsolid::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::Tet21Stokes::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::ZZErrorEstimator::estimateError(), oofem::HuertaErrorEstimator::estimateError(), oofem::DirectErrorIndicatorRC::estimateMeshDensities(), oofem::ZZRemeshingCriteria::estimateMeshDensities(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::NURBSInterpolation::evaldNdx(), oofem::NURBSInterpolation::evalN(), oofem::FEI2dQuadConst::evalN(), oofem::FEI3dHexaLin::evalN(), oofem::FEI3dTetLin::evalN(), oofem::FEI3dHexaTriQuad::evalN(), oofem::FEI3dLineLin::evalN(), oofem::FEI1dHermite::evalN(), oofem::FEI3dTetQuad::evalN(), oofem::FEI2dQuadBiQuad::evalN(), oofem::FEI1dLin::evalN(), oofem::FEI1dQuad::evalN(), oofem::FEI3dWedgeQuad::evalN(), oofem::FEI3dWedgeLin::evalN(), oofem::FEI2dLineHermite::evalN(), oofem::FEI2dLineLin::evalN(), oofem::FEI2dLineQuad::evalN(), oofem::TSplineInterpolation::evalN(), oofem::FEI3dHexaQuad::evalN(), oofem::BSplineInterpolation::evalN(), oofem::CalculatorFunction::evaluate(), oofem::UniformGridField::evaluateAt(), oofem::CohesiveSurface3d::evaluateCenter(), oofem::DiscontinuousFunction::evaluateEnrFuncDerivAt(), oofem::HeavisideFunction::evaluateEnrFuncDerivAt(), oofem::RampFunction::evaluateEnrFuncDerivAt(), oofem::MixedGradientPressureWeakPeriodic::evaluateTractionBasisFunctions(), oofem::VTKExportModule::exportIntVarAs(), oofem::VTKExportModule::exportPrimVarAs(), oofem::HuertaErrorEstimator::extractVectorFrom(), oofem::SkylineUnsym::factorized(), oofem::FCMMaterialStatus::FCMMaterialStatus(), oofem::LIBeam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LIBeam3d2::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::Beam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::ParticleTopologyDescription::findDisplacement(), oofem::LevelSetPCS::FMMReinitialization(), oofem::FRCFCMNLStatus::FRCFCMNLStatus(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase2D(), oofem::MixedGradientPressureNeumann::fromDeviatoricBase3D(), oofem::RheoChainMaterial::generateLogTimeScale(), oofem::ParticleTopologyDescription::generatePSLG(), oofem::PythonExpression::getArray(), oofem::VTKXMLExportModule::getCellVariableFromIS(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::ParticleGrid< Point >::getGridCoord(), oofem::VTKXMLExportModule::getNodalVariableFromIS(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLExportModule::getNodalVariableFromXFEMST(), oofem::RotatingBoundary::give(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::HydratingHeMoMaterial::giveCharacteristicValue(), oofem::HydratingIsoHeatMaterial::giveCharacteristicValue(), oofem::TransportElement::giveCharacteristicVector(), oofem::SUPGElement2::giveCharacteristicVector(), oofem::PFEMElement::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::TR_SHELL02::giveCharacteristicVector(), oofem::TR_SHELL01::giveCharacteristicVector(), oofem::StructuralElement::giveCharacteristicVector(), oofem::CompoDamageMat::giveCharLengthForModes(), oofem::DofManager::giveCompleteUnknownVector(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::Lattice2d::giveCrossSectionCoordinates(), oofem::Lattice2d_mt::giveCrossSectionCoordinates(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::FEI3dTrLin::giveDerivativeEta(), oofem::FEI3dTrQuad::giveDerivativeEta(), oofem::FEI3dTrLin::giveDerivativeXi(), oofem::FEI3dTrQuad::giveDerivativeXi(), oofem::MITC4Shell::giveDirectorVectors(), oofem::MITC4Shell::givedNdx(), oofem::WeakPeriodicBoundaryCondition::giveEdgeNormal(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::LevelSetPCS::giveElementMaterialMixture(), oofem::LEPlic::giveElementMaterialMixture(), oofem::IntMatCoulombContact::giveEngTraction_1d(), oofem::CebFipSlip90Material::giveEngTraction_1d(), oofem::IntMatCoulombContact::giveEngTraction_2d(), oofem::CohesiveInterfaceMaterial::giveEngTraction_3d(), oofem::IntMatPhaseField::giveEngTraction_3d(), oofem::SimpleInterfaceMaterial::giveEngTraction_3d(), oofem::IntMatCoulombContact::giveEngTraction_3d(), oofem::ExpCZMaterial::giveEngTraction_3d(), oofem::BondCEBMaterial::giveEngTraction_3d(), oofem::PrescribedMean::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::OOFEMTXTInputRecord::giveField(), oofem::IntMatDummyCZ::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZ::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZElastic::giveFirstPKTraction_3d(), oofem::HeMoBazNajMaterial::giveFluxVector(), oofem::HeMoTKMaterial::giveFluxVector(), oofem::HeMoKunzelMaterial::giveFluxVector(), oofem::StructuralMaterial::giveFullSymVectorForm(), oofem::StructuralMaterial::giveFullVectorForm(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::Circle::giveGlobalCoordinates(), oofem::Lattice2d::giveGpCoordinates(), oofem::Lattice2d_mt::giveGpCoordinates(), oofem::PolygonLine::giveInputRecord(), oofem::LayeredCrossSection::giveInterfaceXiCoords(), oofem::StructuralEngngModel::giveInternalForces(), oofem::Shell7BaseXFEM::giveInternalForcesVector(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::NodalSpringElement::giveInternalForcesVector(), oofem::GradDpElement::giveInternalForcesVector(), oofem::HTSelement::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::SpringElement::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::IntElLine1PF::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::IDGMaterial::giveInternalLengthDerivative(), oofem::SUPGElement2::giveInternalStateAtNode(), oofem::CBSElement::giveInternalStateAtNode(), oofem::PFEMElement::giveInternalStateAtNode(), oofem::TR1_2D_PFEM::giveInternalStateAtNode(), oofem::TransportElement::giveInternalStateAtNode(), oofem::TR1_2D_CBS::giveInternalStateAtNode(), oofem::SUPGElement::giveInternalStateAtNode(), oofem::StructuralElement::giveInternalStateAtNode(), oofem::Element::giveInternalStateAtNode(), oofem::IsotropicMoistureTransferMaterial::giveIPValue(), oofem::TrPlaneStrRot3d::giveIPValue(), oofem::HydratingHeMoMaterial::giveIPValue(), oofem::IsotropicHeatTransferMaterial::giveIPValue(), oofem::tet21ghostsolid::giveIPValue(), oofem::Quad1PlateSubSoil::giveIPValue(), oofem::HydratingConcreteMat::giveIPValue(), oofem::CCTPlate3d::giveIPValue(), oofem::LinQuad3DPlaneStress::giveIPValue(), oofem::TrPlanestressRotAllman3d::giveIPValue(), oofem::Quad1Mindlin::giveIPValue(), oofem::RerShell::giveIPValue(), oofem::HydratingIsoHeatMaterial::giveIPValue(), oofem::Quad1MindlinShell3D::giveIPValue(), oofem::DKTPlate3d::giveIPValue(), oofem::CemhydMat::giveIPValue(), oofem::RVEStokesFlow::giveIPValue(), oofem::HeMoBazNajMaterial::giveIPValue(), oofem::FRCFCM::giveIPValue(), oofem::CCTPlate::giveIPValue(), oofem::StructuralPythonMaterial::giveIPValue(), oofem::CebFipSlip90Material::giveIPValue(), oofem::IntMatBilinearCZElastic::giveIPValue(), oofem::RankineMatGrad::giveIPValue(), oofem::FRCFCMNL::giveIPValue(), oofem::TrabBoneEmbed::giveIPValue(), oofem::MITC4Shell::giveIPValue(), oofem::StructuralInterfaceCrossSection::giveIPValue(), oofem::IntMatBilinearCZ::giveIPValue(), oofem::BondCEBMaterial::giveIPValue(), oofem::QDKTPlate::giveIPValue(), oofem::MisesMat::giveIPValue(), oofem::TR1_2D_CBS::giveIPValue(), oofem::IntMatIsoDamage::giveIPValue(), oofem::IsoInterfaceDamageMaterial::giveIPValue(), oofem::Beam2d::giveIPValue(), oofem::HeMoTKMaterial::giveIPValue(), oofem::DKTPlate::giveIPValue(), oofem::DruckerPragerCutMat::giveIPValue(), oofem::TR1_2D_SUPG2::giveIPValue(), oofem::SimpleCrossSection::giveIPValue(), oofem::Beam3d::giveIPValue(), oofem::IDNLMaterial::giveIPValue(), oofem::IsoInterfaceDamageMaterial_2::giveIPValue(), oofem::FluidDynamicMaterial::giveIPValue(), oofem::HeMoKunzelMaterial::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::RankineMatNl::giveIPValue(), oofem::RankineMat::giveIPValue(), oofem::IntMatBilinearCZJansson::giveIPValue(), oofem::IntMatBilinearCZFagerstrom::giveIPValue(), oofem::CrossSection::giveIPValue(), oofem::Material::giveIPValue(), oofem::IsotropicDamageMaterial::giveIPValue(), oofem::RheoChainMaterial::giveIPValue(), oofem::RCM2Material::giveIPValue(), oofem::TrabBone3D::giveIPValue(), oofem::MPSDamMaterial::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::MPSMaterial::giveIPValue(), oofem::MDM::giveIPValue(), oofem::DruckerPragerPlasticitySM::giveIPValue(), oofem::LatticeDamage2d::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::DustMaterial::giveIPValue(), oofem::ConcreteDPM::giveIPValue(), oofem::Element::giveIPValue(), oofem::ConcreteDPM2::giveIPValue(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::Shell7Base::giveMassFactorsAt(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::LEPlic::giveMaterialMixtureAt(), oofem::Shell7BaseXFEM::giveMaxCZDamages(), oofem::MicroplaneMaterial::giveMicroplaneNormal(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::TrPlaneStrRot3d::giveNodeCoordinates(), oofem::GradDpElement::giveNonlocalInternalForcesVector(), oofem::PolygonLine::giveNormal(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::DofManager::givePrescribedUnknownVector(), oofem::LatticeDamage2d::giveRandomParameters(), oofem::M4Material::giveRealMicroplaneStressVector(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::LayeredCrossSection::giveRealStress_3dDegeneratedShell(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), oofem::FRCFCMNL::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::LatticeDamage2d::giveRealStressVector(), oofem::TrabBoneNL::giveRealStressVector_1d(), oofem::TrabBoneMaterial::giveRealStressVector_1d(), oofem::MicroplaneMaterial_Bazant::giveRealStressVector_3d(), oofem::HyperElasticMaterial::giveRealStressVector_3d(), oofem::M1Material::giveRealStressVector_3d(), oofem::TrabBoneNLEmbed::giveRealStressVector_3d(), oofem::TrabBoneEmbed::giveRealStressVector_3d(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::B3Material::giveShrinkageStrainVector(), oofem::B3SolidMaterial::giveShrinkageStrainVector(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::FluidDynamicMaterial::giveStiffnessMatrices(), oofem::J2MPlasticMaterial::giveStressBackVector(), oofem::J2plasticMaterial::giveStressBackVector(), oofem::J2Mat::giveStressBackVector(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::GaussIntegrationRule::giveTetCoordsAndWeights(), oofem::SimpleVitrificationMaterial::giveThermalDilatationVector(), oofem::M4Material::giveThermalDilatationVector(), oofem::IsotropicLinearElasticMaterial::giveThermalDilatationVector(), oofem::RheoChainMaterial::giveThermalDilatationVector(), oofem::IsotropicDamageMaterial::giveThermalDilatationVector(), oofem::StructuralMaterial::giveThermalDilatationVector(), oofem::MDM::giveThermalDilatationVector(), oofem::LatticeDamage2d::giveThermalDilatationVector(), oofem::tet21ghostsolid::giveUnknownData(), oofem::ActiveDof::giveUnknowns(), oofem::SlaveDof::giveUnknowns(), oofem::Dof::giveUnknowns(), oofem::PrimaryField::giveUnknownValue(), oofem::DofManager::giveUnknownVector(), oofem::DofManager::giveUnknownVectorOfType(), oofem::LEPlic::giveUpdatedCoordinate(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::FEI3dHexaLin::global2local(), oofem::FEI2dTrConst::global2local(), oofem::FEI3dTetLin::global2local(), oofem::FEI2dTrLin::global2local(), oofem::FEI2dQuadLin::global2local(), oofem::FEI2dLineLin::global2local(), oofem::FEI2dLineQuad::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI1dHermite::global2local(), oofem::FEI3dTrQuad::global2local(), oofem::FEI2dLineHermite::global2local(), oofem::FEI1dLin::global2local(), oofem::FEI1dQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEInterpolation2d::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::Quad1PlaneStrain::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::PlaneStress2d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::TrPlaneStrain::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::LSpace::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::LTRSpace::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::TrPlaneStress2d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::Truss1d::HuertaErrorEstimatorI_setupRefinedElementProblem(), oofem::DynCompRow::ILUPsolve(), oofem::DynCompRow::ILUPtrans_solve(), oofem::DynCompRow::ILUPYourself(), oofem::DiagPreconditioner::init(), oofem::CompCol_ICPreconditioner::initialize(), oofem::DofDistributedPrimaryField::initialize(), oofem::CompCol_ILUPreconditioner::initialize(), oofem::LevelSetPCS::initialize(), oofem::AdaptiveNonLinearStatic::initializeAdaptiveFrom(), oofem::PhaseFieldElement::initializeFrom(), oofem::PiecewiseLinFunction::initializeFrom(), oofem::InterpolatingFuction::initializeFrom(), oofem::SlaveNode::initializeFrom(), oofem::GravityPressure::initializeFrom(), oofem::AnisotropicLinearElasticMaterial::initializeFrom(), oofem::PrescribedGradientHomogenization::initializeFrom(), oofem::NeumannMomentLoad::initializeFrom(), oofem::TransportGradientDirichlet::initializeFrom(), oofem::NodalSpringElement::initializeFrom(), oofem::IGAElement::initializeFrom(), oofem::PrescribedGenStrainShell7::initializeFrom(), oofem::IntMatIsoDamageTable::initializeFrom(), oofem::Lattice2d_mt::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::FRCFCM::initializeFrom(), oofem::BoundaryCondition::initializeFrom(), oofem::MixedGradientPressureDirichlet::initializeFrom(), oofem::IGATSplineElement::initializeFrom(), oofem::CemhydMat::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::NRSolver::initializeFrom(), oofem::IsoInterfaceDamageMaterial_2::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::DIIDynamic::initializeYourself(), oofem::NonLinearDynamic::initializeYourself(), oofem::MisesMatGradStatus::initTempStatus(), oofem::RankineMatGradStatus::initTempStatus(), oofem::PlasticMaterialStatus::initTempStatus(), oofem::RCSDNLMaterialStatus::initTempStatus(), oofem::PerfectlyPlasticMaterialStatus::initTempStatus(), oofem::MPlasticMaterialStatus::initTempStatus(), oofem::StructuralMaterialStatus::initTempStatus(), oofem::StructuralInterfaceMaterialStatus::initTempStatus(), oofem::MPlasticMaterial2Status::initTempStatus(), oofem::TutorialMaterialStatus::initTempStatus(), oofem::Concrete2MaterialStatus::initTempStatus(), oofem::RankineMatStatus::initTempStatus(), oofem::IntElLine1PF::IntElLine1PF(), oofem::IntElPoint::IntElPoint(), oofem::InterfaceElem1d::InterfaceElem1d(), oofem::HybridEI::interpGradLevelSet(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::MMAShapeFunctProjection::interpolateIntVarAt(), oofem::Quasicontinuum::intersectionTestSegmentSegment2D(), oofem::Quasicontinuum::intersectionTestSegmentTrianglePlucker3D(), oofem::IntMatBilinearCZFagerstromStatus::IntMatBilinearCZFagerstromStatus(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::IntMatCoulombContactStatus::IntMatCoulombContactStatus(), oofem::QCFullsolveddomain::isNodeInside(), oofem::IsotropicDamageMaterialStatus::IsotropicDamageMaterialStatus(), oofem::FRCFCMNL::isStrengthExceeded(), oofem::FloatMatrix::jaco_(), oofem::StressStrainBaseVector::letStressStrainModeBe(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::NURBSInterpolation::local2global(), oofem::FEI2dQuadConst::local2global(), oofem::FEI2dTrConst::local2global(), oofem::FEI2dTrLin::local2global(), oofem::FEI2dTrQuad::local2global(), oofem::FEI2dLineLin::local2global(), oofem::FEI2dLineQuad::local2global(), oofem::FEI3dTrLin::local2global(), oofem::FEI1dHermite::local2global(), oofem::FEI2dLineHermite::local2global(), oofem::FEI1dQuad::local2global(), oofem::FEI3dWedgeQuad::local2global(), oofem::FEI1dLin::local2global(), oofem::FEI2dQuadQuad::local2global(), oofem::TSplineInterpolation::local2global(), oofem::BSplineInterpolation::local2global(), oofem::ls2fit(), oofem::Tet1_3D_SUPG::LS_PCS_computeVOFFractions(), oofem::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG_AXI::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::VTKXMLExportModule::makeFullTensorForm(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::Shell7BaseXFEM::mapXi3FromLocalToShell(), oofem::FETISolver::masterMapGammas(), oofem::MisesMatStatus::MisesMatStatus(), oofem::MPSDamMaterialStatus::MPSDamMaterialStatus(), oofem::MPSMaterialStatus::MPSMaterialStatus(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::tet21ghostsolid::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Hexa21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tet21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tr21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalAveragingRecoveryMI_computeSideValue(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7Base::NodalRecoveryMI_computeNNMatrix(), oofem::Shell7Base::NodalRecoveryMI_computeNValProduct(), oofem::QClinearStatic::nodeInFullSolvedDomainTest(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::LevelSetPCS::pcs_stage1(), oofem::MisesMat::performPlasticityReturn(), oofem::TrabBoneEmbed::performPlasticityReturn(), oofem::ConcreteDPM2::performRegularReturn(), oofem::SolidShell::postInitialize(), oofem::AbaqusUserElement::postInitialize(), oofem::NonLinearDynamic::proceedStep(), oofem::NonLinearStatic::proceedStep(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::RCSDNLMaterialStatus::RCSDNLMaterialStatus(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), oofem::M1MaterialStatus::restoreContext(), oofem::PetscSparseMtrx::scatterG2L(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::BoundingBox::setOrigin(), oofem::MixedGradientPressureNeumann::setPrescribedDeviatoricGradientFromVoigt(), oofem::Shell7Base::setupInitialEdgeSolutionVector(), oofem::Shell7Base::setupInitialSolutionVector(), oofem::LayeredCrossSection::setupLayerMidPlanes(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), oofem::ParticleTopologyDescription::shortestDistanceFromCurve(), oofem::SimpleInterfaceMaterialStatus::SimpleInterfaceMaterialStatus(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::DiagPreconditioner::solve(), oofem::MKLPardisoSolver::solve(), oofem::PetscSolver::solve(), oofem::SLEPcSolver::solve(), oofem::DynamicRelaxationSolver::solve(), oofem::PardisoProjectOrgSolver::solve(), oofem::GJacobi::solve(), oofem::SuperLUSolver::solve(), oofem::CompCol_ILUPreconditioner::solve(), oofem::LineSearchNM::solve(), oofem::InverseIteration::solve(), oofem::SpoolesSolver::solve(), oofem::SubspaceIteration::solve(), oofem::FETISolver::solve(), oofem::StaggeredSolver::solve(), oofem::NRSolver::solve(), oofem::CylindricalALM::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::DarcyFlow::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::LinearStatic::solveYourselfAt(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::FreeWarping::solveYourselfAt(), oofem::DEIDynamic::solveYourselfAt(), oofem::EigenValueDynamic::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::TransientTransportProblem::solveYourselfAt(), oofem::DIIDynamic::solveYourselfAt(), oofem::NlDEIDynamic::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::CBS::solveYourselfAt(), oofem::StressStrainBaseVector::StressStrainBaseVector(), oofem::StructuralMaterialStatus::StructuralMaterialStatus(), oofem::FEI3dTrLin::surfaceEvalBaseVectorsAt(), oofem::FEI3dHexaTriQuad::surfaceEvalN(), oofem::FEI3dHexaLin::surfaceEvalN(), oofem::FEI3dTetLin::surfaceEvalN(), oofem::FEI3dWedgeQuad::surfaceEvalN(), oofem::FEI3dTrLin::surfaceEvalN(), oofem::FEI3dTetQuad::surfaceEvalN(), oofem::FEI3dWedgeLin::surfaceEvalN(), oofem::FEI3dTrQuad::surfaceEvalN(), oofem::FEI3dHexaQuad::surfaceEvalN(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dHexaLin::surfaceLocal2global(), oofem::FEI3dTetLin::surfaceLocal2global(), oofem::FEI3dTrLin::surfaceLocal2global(), oofem::PetscSparseMtrx::times(), oofem::SpoolesSparseMtrx::times(), oofem::SkylineUnsym::times(), oofem::DynCompRow::times(), oofem::DynCompCol::times(), oofem::Skyline::times(), oofem::SymCompCol::times(), oofem::CompCol::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::PetscSparseMtrx::timesT(), oofem::SkylineUnsym::timesT(), oofem::SpoolesSparseMtrx::timesT(), oofem::DynCompRow::timesT(), oofem::DynCompCol::timesT(), oofem::CompCol::timesT(), oofem::TrabBone3DStatus::TrabBone3DStatus(), oofem::TrabBoneMaterialStatus::TrabBoneMaterialStatus(), oofem::DiagPreconditioner::trans_solve(), oofem::CompCol_ILUPreconditioner::trans_solve(), oofem::Tr_Warp::transformCoordinates(), oofem::Line::transformIntoPolar(), oofem::MDM::transformStrainToPDC(), oofem::MDM::transformStressFromPDC(), oofem::TutorialMaterialStatus::TutorialMaterialStatus(), oofem::FETISolver::unpackGammas(), oofem::NonLinearDynamic::unpackMigratingData(), oofem::NonLinearStatic::unpackMigratingData(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::NodalRecoveryModel::updateRegionRecoveredValues(), oofem::AdaptiveNonLinearStatic::updateYourself(), oofem::SUPGInternalForceAssembler::vectorFromElement(), oofem::VTKXMLExportModule::writeCellVars(), oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt(), 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().

void oofem::FloatArray::resizeWithValues ( int  s,
int  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 615 of file floatarray.C.

References OOFEM_FATAL, and values.

Referenced by addSubVector(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::InterfaceElem1d::computeLocalSlipDir(), oofem::IntElPoint::computeLocalSlipDir(), oofem::Line::computeNumberOfIntersectionPoints(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::PolygonLine::computeTangentialSignDist(), copySubVector(), oofem::PrescribedGradientBCWeak::createTractionMesh(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7BaseXFEM::EvaluateEnrFuncInDofMan(), oofem::VTKXMLExportModule::exportIntVarsInGpAs(), oofem::VTKXMLExportModule::getCellVariableFromIS(), oofem::VTKXMLExportModule::getNodalVariableFromIS(), oofem::VTKXMLExportModule::getNodalVariableFromXFEMST(), oofem::PrescribedGradient::give(), oofem::Element::giveGlobalIPValue(), oofem::StructuralInterfaceMaterial::giveIPValue(), oofem::TransportMaterial::giveIPValue(), oofem::Shell7BaseXFEM::giveLocalNodeCoordsForExport(), oofem::RCM2Material::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::DofManager::giveUnknownVector(), oofem::DynCompRow::ILUPYourself(), oofem::DynCompRow::insertColInRow(), oofem::DynCompCol::insertRowInColumn(), oofem::GeometryBasedEI::updateLevelSets(), oofem::GeometryBasedEI::updateNodeEnrMarker(), and oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay().

contextIOResultType oofem::FloatArray::restoreYourself ( DataStream stream)

Definition at line 895 of file floatarray.C.

References oofem::CIO_IOERR, oofem::CIO_OK, oofem::DataStream::read(), and values.

Referenced by oofem::PiecewiseLinFunction::restoreContext(), oofem::FluidDynamicMaterialStatus::restoreContext(), oofem::TransportMaterialStatus::restoreContext(), oofem::PlasticMaterialStatus::restoreContext(), oofem::PerfectlyPlasticMaterialStatus::restoreContext(), oofem::LinearStatic::restoreContext(), oofem::RCSDNLMaterialStatus::restoreContext(), oofem::MPlasticMaterialStatus::restoreContext(), oofem::EigenValueDynamic::restoreContext(), oofem::FRCFCMNLStatus::restoreContext(), oofem::DruckerPragerPlasticitySMStatus::restoreContext(), oofem::StructuralMaterialStatus::restoreContext(), oofem::LIBeam3dNL2::restoreContext(), oofem::MPlasticMaterial2Status::restoreContext(), oofem::RheoChainMaterialStatus::restoreContext(), oofem::LinearStability::restoreContext(), oofem::LinearConstraintBC::restoreContext(), oofem::Lattice2d::restoreContext(), oofem::DIIDynamic::restoreContext(), oofem::BoundaryCondition::restoreContext(), oofem::AdaptiveNonLinearStatic::restoreContext(), oofem::NonLinearDynamic::restoreContext(), oofem::Concrete2MaterialStatus::restoreContext(), oofem::SlaveDof::restoreContext(), oofem::MDMStatus::restoreContext(), oofem::LEPlicElementInterface::restoreContext(), oofem::NlDEIDynamic::restoreContext(), oofem::ConcreteDPMStatus::restoreContext(), oofem::MPSDamMaterialStatus::restoreContext(), oofem::TrabBone3DStatus::restoreContext(), oofem::NonLinearStatic::restoreContext(), oofem::RCM2MaterialStatus::restoreContext(), oofem::SUPG::restoreContext(), oofem::LevelSetPCS::restoreContext(), oofem::HuertaErrorEstimator::restoreContext(), oofem::ConcreteDPM2Status::restoreContext(), oofem::Node::restoreContext(), oofem::FCMMaterialStatus::restoreContext(), oofem::MisesMatStatus::restoreContext(), oofem::CBS::restoreContext(), oofem::IntegrationRule::restoreContext(), oofem::LatticeDamage2dStatus::restoreContext(), oofem::RankineMatStatus::restoreContext(), oofem::StressStrainBaseVector::restoreYourself(), and oofem::RCSDNLMaterial::unpackAndUpdateUnknowns().

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 799 of file floatarray.C.

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

Referenced by oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::EngngModel::assembleVectorFromElements(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::RerShell::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::Node::computeLoadVector(), oofem::RigidArmNode::computeMasterContribution(), oofem::StructuralElement::computePointLoadVectorAt(), oofem::StructuralInterfaceElement::computeTraction(), oofem::StructuralInterfaceElementPhF::computeTraction(), oofem::Element::computeVectorOf(), oofem::Element::computeVectorOfPrescribed(), oofem::Node::drawYourself(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::FCMMaterial::giveIPValue(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::DofManager::givePrescribedUnknownVector(), oofem::FRCFCMNL::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::DofManager::giveUnknownVector(), oofem::IsotropicDamageMaterial1::initDamaged(), and oofem::Shell7BaseXFEM::recoverShearStress().

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

Definition at line 872 of file floatarray.C.

References oofem::CIO_IOERR, oofem::CIO_OK, and giveSize().

Referenced by oofem::RCSDNLMaterial::packUnknowns(), oofem::PiecewiseLinFunction::saveContext(), oofem::FluidDynamicMaterialStatus::saveContext(), oofem::TransportMaterialStatus::saveContext(), oofem::PlasticMaterialStatus::saveContext(), oofem::PerfectlyPlasticMaterialStatus::saveContext(), oofem::LinearStatic::saveContext(), oofem::RCSDNLMaterialStatus::saveContext(), oofem::MPlasticMaterialStatus::saveContext(), oofem::EigenValueDynamic::saveContext(), oofem::FRCFCMNLStatus::saveContext(), oofem::DruckerPragerPlasticitySMStatus::saveContext(), oofem::StructuralMaterialStatus::saveContext(), oofem::LIBeam3dNL2::saveContext(), oofem::MPlasticMaterial2Status::saveContext(), oofem::RheoChainMaterialStatus::saveContext(), oofem::LinearStability::saveContext(), oofem::LinearConstraintBC::saveContext(), oofem::Lattice2d::saveContext(), oofem::DIIDynamic::saveContext(), oofem::BoundaryCondition::saveContext(), oofem::AdaptiveNonLinearStatic::saveContext(), oofem::NonLinearDynamic::saveContext(), oofem::LEPlicElementInterface::saveContext(), oofem::Concrete2MaterialStatus::saveContext(), oofem::SlaveDof::saveContext(), oofem::MDMStatus::saveContext(), oofem::NlDEIDynamic::saveContext(), oofem::ConcreteDPMStatus::saveContext(), oofem::MPSDamMaterialStatus::saveContext(), oofem::TrabBone3DStatus::saveContext(), oofem::NonLinearStatic::saveContext(), oofem::RCM2MaterialStatus::saveContext(), oofem::SUPG::saveContext(), oofem::LevelSetPCS::saveContext(), oofem::HuertaErrorEstimator::saveContext(), oofem::FCMMaterialStatus::saveContext(), oofem::ConcreteDPM2Status::saveContext(), oofem::Node::saveContext(), oofem::IntegrationRule::saveContext(), oofem::MisesMatStatus::saveContext(), oofem::CBS::saveContext(), oofem::LatticeDamage2dStatus::saveContext(), oofem::RankineMatStatus::saveContext(), and oofem::StressStrainBaseVector::storeYourself().

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 258 of file floatarray.C.

References FAST_RESIZE, giveSize(), isEmpty(), and OOFEM_ERROR.

Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::CylindricalALM::checkConvergence(), oofem::ConcreteDPM2::checkForUnAndReloading(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::ConcreteDPM2::compute3dSecantStiffness(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::NLStructuralElement::computeDeformationGradientVector(), oofem::tet21ghostsolid::computeDeformationGradientVectorFromDispl(), oofem::ConcreteDPM::computeDuctilityMeasureDamage(), oofem::TransportGradientNeumann::computeEta(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::Shell7BaseXFEM::computeInterfaceJumpAt(), oofem::LinearEdgeLoad::computeNArray(), oofem::StructuralEngngModel::computeReaction(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::StructuralElement::computeStrainVector(), oofem::IDNLMaterial::computeStressBasedWeight(), oofem::IDNLMaterial::computeStressBasedWeightForPeriodicCell(), oofem::SteelRelaxMat::computeStressRelaxationStrainVector(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::ConcreteDPM2Status::computeWork(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::RotatingBoundary::give(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::StokesFlowVelocityHomogenization::giveAreaOfRVE(), oofem::UnstructuredGridField::Cell::giveBoundingBox(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::Beam2d::giveEndForcesVector(), oofem::Beam3d::giveEndForcesVector(), oofem::SimpleInterfaceMaterial::giveEngTraction_3d(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::TrPlaneStress2dXFEM::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_u(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::TrPlaneStrRot3d::giveLocalCoordinates(), oofem::DKTPlate3d::giveLocalCoordinates(), oofem::CCTPlate3d::giveLocalCoordinates(), oofem::MITC4Shell::giveLocalCoordinates(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FCMMaterial::giveRealStressVector(), oofem::ConcreteDPM2::giveRealStressVector_1d(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::ConcreteDPM2::giveRealStressVector_3d(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::Shell7Base::giveShellExportData(), oofem::B3Material::giveShrinkageStrainVector(), oofem::B3SolidMaterial::giveShrinkageStrainVector(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::SteelRelaxMat::giveStressDependentPartOfStrainVector(), oofem::StructuralMaterial::giveStressDependentPartOfStrainVector(), oofem::StructuralMaterial::giveStressDependentPartOfStrainVector_3d(), oofem::DruckerPragerPlasticitySM::giveVertexAlgorithmicStiffMatrix(), oofem::FEI3dHexaLin::global2local(), oofem::PrimaryField::initialize(), oofem::operator-=(), oofem::DruckerPragerPlasticitySM::performLocalStressReturn(), oofem::MisesMat::performPlasticityReturn(), oofem::RankineMat::performPlasticityReturn(), oofem::ConcreteDPM::performPlasticityReturn(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::ConcreteDPM2::performRegularReturn(), oofem::DustMaterial::performStressReturn(), oofem::ConcreteDPM2Status::printOutputAt(), oofem::NonLinearDynamic::proceedStep(), oofem::FETISolver::projection(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::FETISolver::solve(), oofem::CylindricalALM::solve(), oofem::IntElLine1PF::solveForLocalDamage(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::LinearStatic::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::DIIDynamic::solveYourselfAt(), oofem::NlDEIDynamic::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::TR_SHELL02::SpatialLocalizerI_giveBBox(), oofem::TR_SHELL01::SpatialLocalizerI_giveBBox(), oofem::NonLinearDynamic::updateComponent(), oofem::StructuralElementEvaluator::updateInternalState(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeDeformationGradientVector(), and oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions().

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

Multiplies receiver with scalar.

Parameters
sScalar to multiply by.

Definition at line 818 of file floatarray.C.

Referenced by oofem::ParticleTopologyDescription::addLineSegment(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::Subdivision::RS_Triangle::bisect(), oofem::Subdivision::RS_Tetra::bisect(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::EnrichmentItem::calcPolarCoord(), oofem::CylindricalALM::checkConvergence(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::LIBeam2d::computeBodyLoadVectorAt(), oofem::LIBeam2dNL::computeBodyLoadVectorAt(), oofem::LIBeam3d::computeBodyLoadVectorAt(), oofem::LIBeam3dNL2::computeBodyLoadVectorAt(), oofem::LIBeam3dNL::computeBodyLoadVectorAt(), oofem::LIBeam3d2::computeBodyLoadVectorAt(), oofem::Beam2d::computeBodyLoadVectorAt(), oofem::Beam3d::computeBodyLoadVectorAt(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::PhaseFieldElement::computeBStress_u(), oofem::Eurocode2CreepMaterial::computeCharCoefficients(), oofem::Load::computeComponentArrayAt(), oofem::Node2NodeContactL::computeContactTangent(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::EnrichmentFront::computeCrackTangent(), oofem::ConcreteDPM::computeDCosThetaDStress(), oofem::LatticeDamage2d::computeDeltaDissipation(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormCompression(), oofem::ConcreteDPM2::computeDeltaPlasticStrainNormTension(), oofem::TrabBone3D::computeDensificationStress(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::NonlinearFluidMaterial::computeDeviatoricStressVector(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::ActiveDof::computeDofTransformation(), oofem::SlaveDof::computeDofTransformation(), oofem::ConcreteDPM::computeDRhoDStress(), oofem::ConcreteDPM2::computeDRhoDStress(), oofem::IntMatCoulombContact::computeEngTraction(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::PrescribedGradientBCWeak::computeExtForceElContrib(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGenStrainShell7::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::PrescribedGradientBCWeak::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::Tr_Warp::computeFirstMomentOfArea(), oofem::IntElPoint::computeGlobalCoordinates(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::MaxwellChainMaterial::computeHiddenVars(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::HydratingHeMoMaterial::computeInternalSourceVector(), oofem::HydratingIsoHeatMaterial::computeInternalSourceVector(), oofem::VTKXMLExportModule::computeIPAverage(), oofem::XfemStructuralElementInterface::computeIPAverageInTriangle(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::MITC4Shell::computeLocalBaseVectors(), oofem::MDM::computeLocalDamageTensor(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::tet21ghostsolid::computeNumericStiffnessMatrix(), oofem::tet21ghostsolid::computeNumericStiffnessMatrixDebug(), oofem::WeakPeriodicBoundaryCondition::computeOrthogonalBasis(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::Shell7Base::computePressureForceAt(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::PhaseFieldElement::computeStiffnessMatrix_ud(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::LIBeam3dNL::computeTempCurv(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::InteractionLoad::computeValueAt(), oofem::ConstantPressureLoad::computeValueAt(), oofem::GravityPressure::computeValueAt(), oofem::NeumannMomentLoad::computeValueAt(), oofem::PointLoad::computeValueAt(), oofem::BoundaryLoad::computeValueAt(), oofem::NeumannMomentLoad::computeXbar(), oofem::TransportGradientDirichlet::computeXi(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::TrabBone3D::constructPlasFlowDirec(), oofem::ContactElement::ContactElement(), oofem::CrackExportModule::doOutput(), oofem::HOMExportModule::doOutput(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::TR_SHELL02::drawScalar(), oofem::TR_SHELL01::drawScalar(), oofem::LSpace::drawTriad(), oofem::FEI2dTrQuad::edgeEvaldNds(), oofem::FEI2dLineLin::edgeEvaldNds(), oofem::FEI2dLineQuad::edgeEvaldNds(), oofem::Shell7BaseXFEM::edgeGiveUpdatedSolutionVector(), oofem::VTKExportModule::exportCellVars(), oofem::PrescribedGradient::give(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::PolygonLine::giveBoundingSphere(), oofem::IsotropicDamageMaterialStatus::giveCrackVector(), oofem::MPSDamMaterialStatus::giveCrackVector(), oofem::PolylineNonlocalBarrier::giveDistancePointLine(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MPSMaterial::giveEigenStrainVector(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::SimpleInterfaceMaterial::giveEngTraction_3d(), oofem::PrescribedMean::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::TwoFluidMaterial::giveIPValue(), oofem::IsotropicDamageMaterial::givePlaneStressStiffMtrx(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::MPlasticMaterial2::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::MisesMat::giveRealStressVector_1d(), oofem::ConcreteDPM2::giveRealStressVector_1d(), oofem::MicroplaneMaterial_Bazant::giveRealStressVector_3d(), oofem::M1Material::giveRealStressVector_3d(), oofem::MisesMat::giveRealStressVector_3d(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::ConcreteDPM2::giveRealStressVector_3d(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::DruckerPragerPlasticitySM::giveRegAlgorithmicStiffMatrix(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::PerfectlyPlasticMaterial::GiveStressCorrectionBackToYieldSurface(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::PrescribedGradientBCWeak::giveTraction(), oofem::Homogenize::herveZaoui(), oofem::FRCFCM::initializeFrom(), oofem::Node::initializeFrom(), oofem::NURBSInterpolation::local2global(), oofem::TSplineInterpolation::local2global(), oofem::Q9PlaneStress2d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QPlaneStress2d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::NodalAveragingRecoveryMI_computeNodalValue(), normalize(), oofem::operator*=(), oofem::GnuplotExportModule::outputGradient(), oofem::MisesMat::performPlasticityReturn(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::DruckerPragerPlasticitySM::performRegularReturn(), oofem::DustMaterial::performStressReturn(), oofem::ConcreteDPM2Status::printOutputAt(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLMaterialForce::propagateInterface(), oofem::ConcreteDPMStatus::restoreConsistency(), oofem::TransportGradientNeumann::scale(), oofem::UserDefDirichletBC::scale(), oofem::BoundaryCondition::scale(), oofem::TransportGradientDirichlet::scale(), oofem::MixedGradientPressureDirichlet::scale(), oofem::MixedGradientPressureNeumann::scale(), oofem::Load::scale(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::Subdivision::smoothMesh(), oofem::LineSearchNM::solve(), oofem::NRSolver::solve(), oofem::CylindricalALM::solve(), oofem::DEIDynamic::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::CBS::solveYourselfAt(), oofem::XfemStructureManager::splitCracks(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::FEI3dTrLin::surfaceEvalNormal(), oofem::FEI3dTrQuad::surfaceEvalNormal(), oofem::DynCompRow::times(), oofem::DynCompCol::times(), oofem::SymCompCol::times(), oofem::CompCol::times(), oofem::Subdivision::unpackSharedIrregulars(), oofem::TransientTransportProblem::updateComponent(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::Tet1_3D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), and oofem::PFEMCorrectionRhsAssembler::vectorFromElement().

void oofem::FloatArray::zero ( )

Zeroes all coefficients of receiver.

Definition at line 658 of file floatarray.C.

References begin(), and end().

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMALeastSquareProjection::__mapVariable(), oofem::AbaqusUserMaterialStatus::AbaqusUserMaterialStatus(), oofem::AdaptiveNonLinearStatic::adaptiveRemap(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::SUPG::applyIC(), oofem::NonStationaryTransportProblem::applyIC(), oofem::CBS::applyIC(), oofem::PFEM::applyIC(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), oofem::EngngModel::assembleExtrapolatedForces(), oofem::NonLinearStatic::assembleIncrementalReferenceLoadVectors(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::DIIDynamic::assembleLoadVector(), oofem::EngngModel::assemblePrescribedExtrapolatedForces(), oofem::EngngModel::assembleVector(), oofem::BinghamFluidMaterial2Status::BinghamFluidMaterial2Status(), oofem::SymCompCol::buildInternalStructure(), oofem::CompCol::buildInternalStructure(), oofem::NRSolver::checkConvergence(), oofem::CylindricalALM::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::FCMMaterial::checkStrengthCriterion(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::CompoDamageMatStatus::CompoDamageMatStatus(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeAdvectionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeAdvectionTerm_MC(), oofem::MPSMaterial::computeB4AutogenousShrinkageStrainVector(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubVectorAt(), oofem::TransportElement::computeBCVectorAt(), oofem::LSpaceBB::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::Quad1Mindlin::computeBmatrixAt(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::TR_SHELL01::computeBodyLoadVectorAt(), oofem::TR1_2D_PFEM::computeBodyLoadVectorAt(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::B3SolidMaterial::computeCharCoefficients(), oofem::Eurocode2CreepMaterial::computeCharCoefficients(), oofem::MPSMaterial::computeCharCoefficients(), oofem::B3SolidMaterial::computeCharTimes(), oofem::Eurocode2CreepMaterial::computeCharTimes(), oofem::RheoChainMaterial::computeCharTimes(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::Shell7BaseXFEM::computeCohesiveForces(), oofem::Load::computeComponentArrayAt(), oofem::Node2NodeContactL::computeContactForces(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::TR1_2D_CBS::computeCorrectionRhs(), oofem::IntElLine1IntPen::computeCovarBaseVectorAt(), oofem::IntElLine2IntPen::computeCovarBaseVectorAt(), oofem::IntElLine1PF::computeCovarBaseVectorAt(), oofem::IntElLine1PhF::computeCovarBaseVectorAt(), oofem::IntElLine1::computeCovarBaseVectorAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::MazarsMaterial::computeDamageParam(), oofem::ConcreteDPM::computeDDKappaDDeltaLambdaDInv(), oofem::TrabBone3D::computeDensificationStress(), 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_SUPG_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::RheoChainMaterial::computeDiscreteRelaxationFunction(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::FRCFCMNL::computeElementCentroid(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::StructuralEngngModel::computeExternalLoadReactionContribution(), oofem::MPSMaterial::computeFibAutogenousShrinkageStrainVector(), oofem::Line2BoundaryElement::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::Hexa21Stokes::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGenStrainShell7::computeField(), oofem::Tr1BubbleStokes::computeField(), oofem::Tr21Stokes::computeField(), oofem::Tet1BubbleStokes::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::TransportElement::computeFlow(), oofem::IntElSurfTr1::computeGlobalCoordinates(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::InterfaceElement3dTrLin::computeGlobalCoordinates(), oofem::Truss2d::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::Eurocode2CreepMaterial::computeIncrementOfAutogenousShrinkageVector(), oofem::Eurocode2CreepMaterial::computeIncrementOfDryingShrinkageVector(), oofem::Tr1Darcy::computeInternalForcesVector(), oofem::Hexa21Stokes::computeInternalForcesVector(), oofem::Tet21Stokes::computeInternalForcesVector(), oofem::Tr21Stokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::TransportElement::computeInternalSourceRhsVectorAt(), oofem::HydratingHeMoMaterial::computeInternalSourceVector(), oofem::HydratingIsoHeatMaterial::computeInternalSourceVector(), oofem::TR21_2D_SUPG::computeIntersection(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::DruckerPragerCutMat::computeKGradientVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::SUPGElement2::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::PFEMElement::computeLoadVector(), oofem::NlDEIDynamic::computeLoadVector(), oofem::RerShell::computeLocalCoordinates(), oofem::CCTPlate::computeLocalCoordinates(), oofem::QDKTPlate::computeLocalCoordinates(), oofem::DKTPlate::computeLocalCoordinates(), oofem::TransportElement::computeLumpedCapacityVector(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::LinearEdgeLoad::computeNArray(), oofem::XfemElementInterface::computeNCohesive(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::TR1_2D_CBS::computeNumberOfNodalPrescribedTractionPressureContributions(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::B3SolidMaterial::computePointShrinkageStrainVector(), oofem::MPSMaterial::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::Shell7Base::computeSectionalForces(), oofem::B3Material::computeShrinkageStrainVector(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::Hexa21Stokes::computeStiffnessMatrix(), oofem::Tet21Stokes::computeStiffnessMatrix(), oofem::Tr21Stokes::computeStiffnessMatrix(), oofem::IntElLine1PF::computeStiffnessMatrix_dd(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::Masonry02::computeStrainHardeningVarsIncrement(), oofem::DruckerPragerCutMat::computeStrainHardeningVarsIncrement(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::StructuralElement::computeStrainVector(), oofem::MicroplaneMaterial::computeStrainVectorComponents(), oofem::J2MPlasticMaterial::computeStressGradientVector(), oofem::J2Mat::computeStressGradientVector(), oofem::Masonry02::computeStressGradientVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::LatticeDamage2d::computeStressIndependentStrainVector(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::B3Material::computeTotalAverageShrinkageStrainVector(), oofem::B3SolidMaterial::computeTotalAverageShrinkageStrainVector(), oofem::Shell7Base::computeTractionForce(), oofem::ConstantEdgeLoad::computeValueAt(), oofem::Load::computeValues(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::NeumannMomentLoad::computeXbar(), oofem::TrabBone3D::constructAnisoFtensor(), oofem::TrabBone3D::constructDerivativeOfPlasFlowDirec(), oofem::ContactElement::ContactElement(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::SuperLUSolver::convertRhs(), oofem::StressStrainBaseVector::convertToFullForm(), oofem::StructuralFE2MaterialStatus::copyStateVariables(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::LEPlic::doCellDLS(), oofem::FEI2dLineHermite::edgeEvald2Nds2(), oofem::FEI2dLineHermite::edgeEvaldNds(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::tet21ghostsolid::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::Tet21Stokes::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::HuertaErrorEstimator::estimateError(), oofem::NURBSInterpolation::evaldNdx(), oofem::BSplineInterpolation::evaldNdx(), oofem::FEI1dHermite::evalN(), oofem::FEI1dQuad::evalN(), oofem::FEI2dLineHermite::evalN(), oofem::DiscontinuousFunction::evaluateEnrFuncDerivAt(), oofem::HeavisideFunction::evaluateEnrFuncDerivAt(), oofem::RampFunction::evaluateEnrFuncDerivAt(), oofem::VTKExportModule::exportIntVarAs(), oofem::VTKExportModule::exportPrimVarAs(), oofem::SkylineUnsym::factorized(), oofem::FCMMaterialStatus::FCMMaterialStatus(), oofem::ParticleTopologyDescription::findDisplacement(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::FRCFCMNLStatus::FRCFCMNLStatus(), oofem::RheoChainMaterial::generateLogTimeScale(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::RotatingBoundary::give(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStress2d::giveCharacteristicSize(), oofem::SUPGElement2::giveCharacteristicVector(), oofem::PFEMElement::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::TR_SHELL02::giveCharacteristicVector(), oofem::TR_SHELL01::giveCharacteristicVector(), oofem::Lattice2d::giveCrossSectionCoordinates(), oofem::Lattice2d_mt::giveCrossSectionCoordinates(), oofem::BinghamFluidMaterial2::giveDeviatoricStiffnessMatrix(), oofem::MITC4Shell::giveDirectorVectors(), oofem::KelvinChainSolidMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::IntMatDummyCZ::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZ::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZElastic::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::HeMoBazNajMaterial::giveFluxVector(), oofem::HeMoTKMaterial::giveFluxVector(), oofem::HeMoKunzelMaterial::giveFluxVector(), oofem::StructuralMaterial::giveFullSymVectorForm(), oofem::StructuralMaterial::giveFullVectorForm(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::StructuralEngngModel::giveInternalForces(), oofem::Shell7BaseXFEM::giveInternalForcesVector(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::GradDpElement::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector(), oofem::Quad1MindlinShell3D::giveInternalForcesVector(), oofem::IntElLine1PF::giveInternalForcesVector(), oofem::StructuralElementEvaluator::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IntElLine1PF::giveInternalForcesVectorUD(), oofem::IntMatIsoDamage::giveIPValue(), oofem::IsoInterfaceDamageMaterial::giveIPValue(), oofem::DruckerPragerCutMat::giveIPValue(), oofem::IDNLMaterial::giveIPValue(), oofem::IsoInterfaceDamageMaterial_2::giveIPValue(), oofem::FE2FluidMaterial::giveIPValue(), oofem::RankineMat::giveIPValue(), oofem::IsotropicDamageMaterial::giveIPValue(), oofem::RheoChainMaterial::giveIPValue(), oofem::MPSDamMaterial::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::AnisotropicDamageMaterial::giveIPValue(), oofem::MPSMaterial::giveIPValue(), oofem::MDM::giveIPValue(), oofem::DruckerPragerPlasticitySM::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::ConcreteDPM::giveIPValue(), oofem::ConcreteDPM2::giveIPValue(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::Shell7BaseXFEM::giveLocalNodeCoordsForExport(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::M4Material::giveRealMicroplaneStressVector(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::LayeredCrossSection::giveRealStress_3dDegeneratedShell(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), oofem::FRCFCMNL::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::LatticeDamage2d::giveRealStressVector(), oofem::ConcreteDPM2::giveRealStressVector_1d(), oofem::MicroplaneMaterial_Bazant::giveRealStressVector_3d(), oofem::M1Material::giveRealStressVector_3d(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::B3Material::giveShrinkageStrainVector(), oofem::B3SolidMaterial::giveShrinkageStrainVector(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::FluidDynamicMaterial::giveStiffnessMatrices(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::M4Material::giveThermalDilatationVector(), oofem::IsotropicLinearElasticMaterial::giveThermalDilatationVector(), oofem::RheoChainMaterial::giveThermalDilatationVector(), oofem::IsotropicDamageMaterial::giveThermalDilatationVector(), oofem::StructuralMaterial::giveThermalDilatationVector(), oofem::MDM::giveThermalDilatationVector(), oofem::LatticeDamage2d::giveThermalDilatationVector(), oofem::tet21ghostsolid::giveUnknownData(), oofem::DofManager::giveUnknownVectorOfType(), oofem::Node::giveUpdatedCoordinate(), oofem::Shell7Base::giveZ2integratedPolynomial2GradientForStressRecAt(), oofem::Shell7Base::giveZintegratedPolynomialGradientForStressRecAt(), oofem::FEI3dHexaLin::global2local(), oofem::FEI2dQuadLin::global2local(), oofem::FEI3dTetQuad::global2local(), oofem::FEI3dWedgeLin::global2local(), oofem::FEInterpolation2d::global2local(), oofem::FEI3dHexaQuad::global2local(), oofem::Homogenize::herveZaoui(), oofem::CompCol_ICPreconditioner::ICSolve(), oofem::DynCompRow::ILUPsolve(), oofem::DiagPreconditioner::init(), oofem::MazarsMaterial::initDamaged(), oofem::DofDistributedPrimaryField::initialize(), oofem::AdaptiveNonLinearStatic::initializeAdaptiveFrom(), oofem::FCMMaterial::initializeCrack(), oofem::InterpolatingFuction::initializeFrom(), oofem::GravityPressure::initializeFrom(), oofem::AnisotropicLinearElasticMaterial::initializeFrom(), oofem::PrescribedGradientHomogenization::initializeFrom(), oofem::NodalSpringElement::initializeFrom(), oofem::PrescribedGenStrainShell7::initializeFrom(), oofem::Lattice2d_mt::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::FRCFCM::initializeFrom(), oofem::BoundaryCondition::initializeFrom(), oofem::MixedGradientPressureDirichlet::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::DIIDynamic::initializeYourself(), oofem::NonLinearDynamic::initializeYourself(), oofem::MisesMatGradStatus::initTempStatus(), oofem::RankineMatGradStatus::initTempStatus(), oofem::PlasticMaterialStatus::initTempStatus(), oofem::PerfectlyPlasticMaterialStatus::initTempStatus(), oofem::MPlasticMaterialStatus::initTempStatus(), oofem::StructuralInterfaceMaterialStatus::initTempStatus(), oofem::MPlasticMaterial2Status::initTempStatus(), oofem::TutorialMaterialStatus::initTempStatus(), oofem::MPSMaterialStatus::initTempStatus(), oofem::Concrete2MaterialStatus::initTempStatus(), oofem::RankineMatStatus::initTempStatus(), oofem::IntElLine1PF::IntElLine1PF(), oofem::IntElPoint::IntElPoint(), oofem::InterfaceElem1d::InterfaceElem1d(), oofem::HybridEI::interpGradLevelSet(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::IntMatBilinearCZFagerstromStatus::IntMatBilinearCZFagerstromStatus(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::IntMatCoulombContactStatus::IntMatCoulombContactStatus(), oofem::IsotropicDamageMaterialStatus::IsotropicDamageMaterialStatus(), oofem::FRCFCMNL::isStrengthExceeded(), oofem::Lattice2d_mt::Lattice2d_mt(), oofem::StressStrainBaseVector::letStressStrainModeBe(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::NURBSInterpolation::local2global(), oofem::FEI2dTrLin::local2global(), oofem::FEI2dLineLin::local2global(), oofem::FEI2dTrQuad::local2global(), oofem::FEI2dLineHermite::local2global(), oofem::FEI3dWedgeQuad::local2global(), oofem::FEI2dQuadQuad::local2global(), oofem::TSplineInterpolation::local2global(), oofem::BSplineInterpolation::local2global(), oofem::ls2fit(), oofem::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::VTKXMLExportModule::makeFullTensorForm(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::MPSDamMaterialStatus::MPSDamMaterialStatus(), oofem::MPSMaterialStatus::MPSMaterialStatus(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Shell7Base::NodalRecoveryMI_computeNValProduct(), oofem::LevelSetPCS::pcs_stage1(), oofem::ConcreteDPM::performRegularReturn(), oofem::ConcreteDPM2::performRegularReturn(), oofem::DruckerPragerPlasticitySM::performVertexReturn(), oofem::SolidShell::postInitialize(), oofem::NonLinearDynamic::proceedStep(), oofem::NonLinearStatic::proceedStep(), oofem::TrabBone3D::projectOnYieldSurface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::M1MaterialStatus::restoreContext(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::BoundaryCondition::setPrescribedValue(), oofem::Shell7Base::setupInitialEdgeSolutionVector(), oofem::Shell7Base::setupInitialSolutionVector(), oofem::SimpleInterfaceMaterialStatus::SimpleInterfaceMaterialStatus(), oofem::Subdivision::smoothMesh(), oofem::DynamicRelaxationSolver::solve(), oofem::CompCol_ILUPreconditioner::solve(), oofem::SubspaceIteration::solve(), oofem::FETISolver::solve(), oofem::StaggeredSolver::solve(), oofem::NRSolver::solve(), oofem::CylindricalALM::solve(), oofem::IntElLine1PF::solveForLocalDamage(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::DarcyFlow::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::LinearStatic::solveYourselfAt(), oofem::FreeWarping::solveYourselfAt(), oofem::DEIDynamic::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::EigenValueDynamic::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::TransientTransportProblem::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::DIIDynamic::solveYourselfAt(), oofem::NlDEIDynamic::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::CBS::solveYourselfAt(), oofem::StressStrainBaseVector::StressStrainBaseVector(), oofem::SpoolesSparseMtrx::times(), oofem::SkylineUnsym::times(), oofem::DynCompRow::times(), oofem::DynCompCol::times(), oofem::Skyline::times(), oofem::SymCompCol::times(), oofem::CompCol::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::SpoolesSparseMtrx::timesT(), oofem::SkylineUnsym::timesT(), oofem::DynCompRow::timesT(), oofem::DynCompCol::timesT(), oofem::CompCol::timesT(), oofem::DarcyFlow::updateComponent(), oofem::StationaryTransportProblem::updateComponent(), oofem::TransientTransportProblem::updateComponent(), oofem::StaticStructural::updateComponent(), oofem::StokesFlow::updateComponent(), oofem::SUPG::updateComponent(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::Shell7Base::updateLayerTransvNormalStressSR(), oofem::NonLinearStatic::updateLoadVectors(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::PerfectlyPlasticMaterialStatus::updateYourself(), oofem::MPSMaterialStatus::updateYourself(), oofem::SUPGInternalForceAssembler::vectorFromElement(), oofem::VTKXMLExportModule::writeVTKPiece(), oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), oofem::DynCompRow::zero(), oofem::DynCompCol::zero(), oofem::SymCompCol::zero(), and oofem::CompCol::zero().

Friends And Related Function Documentation

friend class FloatMatrix
friend

Definition at line 509 of file floatarray.h.

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

Definition at line 1079 of file floatarray.C.

Member Data Documentation


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

This page is part of the OOFEM documentation. Copyright (c) 2011 Borek Patzak
Project e-mail: info@oofem.org
Generated at Tue Jan 2 2018 20:07:35 for OOFEM by doxygen 1.8.11 written by Dimitri van Heesch, © 1997-2011