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

Class implementing an array of integers. More...

#include <intarray.h>

Public Member Functions

 IntArray (int n=0)
 Constructor for sized array. Data is zeroed. More...
 
 IntArray (const IntArray &src)
 Copy constructor. Creates the array from another array. More...
 
 IntArray (IntArray &&src)
 Move constructor. Creates the array from another array. More...
 
 IntArray (std::initializer_list< int >list)
 Initializer list constructor. More...
 
 ~IntArray ()
 Destructor. More...
 
IntArrayoperator= (const IntArray &src)
 Assignment operator. More...
 
IntArrayoperator= (IntArray &&src)
 Move operator. More...
 
IntArrayoperator= (std::initializer_list< int >list)
 Assignment operator. More...
 
int & at (int i)
 Coefficient access function. More...
 
int at (int i) const
 Coefficient access function. More...
 
int & operator() (int i)
 Coefficient access function. More...
 
const int & operator() (int i) const
 Coefficient access function. More...
 
int & operator[] (int i)
 
const int & operator[] (int i) const
 
void resizeWithValues (int n, int allocChunk=0)
 Checks size of receiver towards requested bounds. More...
 
void resize (int n)
 Checks size of receiver towards requested bounds. More...
 
void clear ()
 Clears the array (zero size). More...
 
void preallocate (int futureSize)
 Preallocates receiver to given futureSize if larger then allocatedSize. More...
 
void enumerate (int maxVal)
 Resizes receiver and enumerates from 1 to the maximum value given. More...
 
void followedBy (const IntArray &b, int allocChunk=0)
 Appends array b at the end of receiver. More...
 
void followedBy (int b, int allocChunk=0)
 Appends given Number at the end of receiver. More...
 
int giveSize () const
 
bool isEmpty () const
 Checks if receiver is empty (i.e., zero sized). More...
 
bool containsOnlyZeroes () const
 Checks if receiver is all zero. More...
 
int findSorted (int value) const
 Finds the first occurrence of given value, assuming that the receiver is sorted. More...
 
int minimum () const
 Finds the minimum component in the array. More...
 
int maximum () const
 Finds the maximum component in the array. More...
 
void findNonzeros (const IntArray &logical)
 Finds all indices where the input array is nonzero. More...
 
bool containsSorted (int value) const
 Checks if sorted receiver contains a given value. More...
 
void insertSorted (int value, int allocChunk=0)
 Inserts given value into a receiver, which is assumed to be sorted. More...
 
bool insertSortedOnce (int value, int allocChunk=0)
 Inserts given value into a receiver, which is assumed to be sorted. More...
 
void eraseSorted (int value)
 Erase the element of given value. More...
 
int findCommonValuesSorted (const IntArray &iarray, IntArray &common, int allocChunk=0) const
 Extracts common values in receiver and iarray. More...
 
int findFirstIndexOf (int value) const
 Finds index of first occurrence of given value in array. More...
 
bool contains (int value) const
 
void insertOnce (int p)
 Insert once (does not make any assumption about receiver state or ordering, quite inefficient). More...
 
void sort ()
 Sorts array. More...
 
void erase (int pos)
 Erase the element at given position (1-based index) Receiver will shrink accordingly, the values at positions (pos+1,...,size) will be moved to positions (pos,...,size-1) More...
 
void add (int val)
 Adds given scalar to all values of receiver. More...
 
void zero ()
 Sets all component to zero. More...
 
void printYourself () const
 Prints receiver on stdout. More...
 
void pY () const
 Abbreviation for printYourself(). More...
 
void printYourself (const std::string name) const
 Prints receiver on stdout with custom name. More...
 
void printYourselfToFile (const std::string filename, const bool showDimensions=true) const
 Print receiver to file. More...
 
bool isFinite () const
 Returns true if no element is NAN or infinite. More...
 
const int * givePointer () const
 Breaks encapsulation. More...
 
int * givePointer ()
 
contextIOResultType storeYourself (DataStream &stream) const
 Stores array to output stream. More...
 
contextIOResultType restoreYourself (DataStream &stream)
 Restores array from image on stream. More...
 
int givePackSize (DataStream &buff) const
 Returns how much space is needed to pack receivers message. More...
 
Iterator for for-each loops:
std::vector< int >::iterator begin ()
 
std::vector< int >::iterator end ()
 
std::vector< int >::const_iterator begin () const
 
std::vector< int >::const_iterator end () const
 

Private Attributes

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

Friends

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

Detailed Description

Class implementing an array of integers.

Acts as a wrapper for std::vector of integers, but adds many convenience functions that are commonly used in OOFEM. Array can grow or shrink to desired dimension. The lower value index of array is 1, upper depends on array size.

Author
Mikael Öhman
Jim Brouzoulis
Erik Svenning
many others (please add yourselves)

Definition at line 61 of file intarray.h.

Constructor & Destructor Documentation

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

Constructor for sized array. Data is zeroed.

Definition at line 77 of file intarray.h.

oofem::IntArray::IntArray ( const IntArray src)
inline

Copy constructor. Creates the array from another array.

Definition at line 79 of file intarray.h.

oofem::IntArray::IntArray ( IntArray &&  src)
inline

Move constructor. Creates the array from another array.

Definition at line 81 of file intarray.h.

oofem::IntArray::IntArray ( std::initializer_list< int >  list)
inline

Initializer list constructor.

Definition at line 83 of file intarray.h.

oofem::IntArray::~IntArray ( )
inline

Destructor.

Definition at line 85 of file intarray.h.

Member Function Documentation

int& oofem::IntArray::at ( int  i)
inline

Coefficient access function.

Returns l-value of coefficient at given position of the receiver.

Parameters
iPosition of coefficient in array.
Returns
Value at position.

Definition at line 103 of file intarray.h.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMAShapeFunctProjection::__init(), oofem::MMALeastSquareProjection::__init(), oofem::AdaptiveNonLinearStatic::adaptiveRemap(), add(), oofem::Quasicontinuum::addCrosssectionToInterpolationElements(), oofem::Element::addDofManager(), oofem::FETIBoundaryDofManager::addPartition(), oofem::Delamination::appendInputRecords(), oofem::Quasicontinuum::applyApproach1(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::SymmetryBarrier::applyConstraint(), oofem::NRSolver::applyConstraintsToLoadIncrement(), oofem::NRSolver::applyConstraintsToStiffness(), oofem::SparseNonLinearSystemNM::applyPerturbation(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedMean::assemble(), oofem::SpoolesSparseMtrx::assemble(), oofem::SkylineUnsym::assemble(), oofem::PetscSparseMtrx::assemble(), oofem::DynCompRow::assemble(), oofem::DynCompCol::assemble(), oofem::LinearConstraintBC::assemble(), oofem::Skyline::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::FloatMatrix::assemble(), oofem::FloatArray::assemble(), oofem::FloatArray::assembleSquared(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::LinearConstraintBC::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromElements(), oofem::Skyline::at(), oofem::Skyline::backSubstitutionWith(), oofem::FloatArray::beSubArrayOf(), oofem::FloatMatrix::beSubMatrixOf(), oofem::Subdivision::RS_Triangle::bisect(), oofem::Subdivision::RS_Tetra::bisect(), oofem::FEInterpolation2d::boundarySurfaceGiveNodes(), oofem::SkylineUnsym::buildInternalStructure(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::DynCompRow::buildInternalStructure(), oofem::Skyline::buildInternalStructure(), oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::StructuralEngngModel::buildReactionTable(), oofem::Subdivision::RS_Node::buildTopLevelNodeConnectivity(), oofem::ParmetisLoadBalancer::calculateLoadTransfer(), oofem::PolylineNonlocalBarrier::calculateMinimumDistanceFromBoundary(), oofem::MacroLSpace::changeMicroBoundaryConditions(), oofem::ReactionErrorCheckingRule::check(), oofem::RigidArmNode::checkConsistency(), oofem::Node::checkConsistency(), oofem::FiberedCrossSection::checkConsistency(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::RCM2Material::checkIfClosedCracks(), oofem::RowColumn::checkSizeTowards(), oofem::SkylineUnsym::checkSizeTowards(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue(), oofem::TR1_2D_SUPG_AXI::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCLhsTerm_MB(), oofem::SUPGElement::computeBCLhsTerm_MB(), oofem::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::TransportElement::computeBCSubMtrxAt(), oofem::TransportElement::computeBCSubVectorAt(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::TR21_2D_SUPG::computeCoordsOfEdge(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::MDM::computeDamageOnPlane(), oofem::CylindricalALM::computeDeltaLambda(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::PrescribedMean::computeDomainSize(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::FEInterpolation2d::computeEdgeMapping(), oofem::FEInterpolation3d::computeEdgeMapping(), oofem::TrPlanestressRotAllman::computeEgdeNMatrixAt(), oofem::EnrichmentItem::computeEnrichedDofManDofIdArray(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::Hexa21Stokes::computeExternalForcesVector(), oofem::Tet21Stokes::computeExternalForcesVector(), oofem::Tr21Stokes::computeExternalForcesVector(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::Set::computeIntArray(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::TR21_2D_SUPG::computeIntersection(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::Node::computeL2GTransformation(), oofem::DKTPlate3d::computeLoadLEToLRotationMatrix(), oofem::CCTPlate::computeLoadLEToLRotationMatrix(), oofem::MITC4Shell::computeLoadLEToLRotationMatrix(), oofem::Quad1Mindlin::computeLoadLEToLRotationMatrix(), oofem::DKTPlate::computeLoadLEToLRotationMatrix(), oofem::QDKTPlate::computeLoadLEToLRotationMatrix(), oofem::Quad1MindlinShell3D::computeLoadLEToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::FEI2dTrConst::computeLocalEdgeMapping(), oofem::FEI2dQuadConst::computeLocalEdgeMapping(), oofem::FEI2dQuadLin::computeLocalEdgeMapping(), oofem::FEI2dTrQuad::computeLocalEdgeMapping(), oofem::FEI2dTrLin::computeLocalEdgeMapping(), oofem::FEI3dTetLin::computeLocalEdgeMapping(), oofem::FEI2dQuadQuad::computeLocalEdgeMapping(), oofem::FEI3dTrQuad::computeLocalEdgeMapping(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::FEI3dTetLin::computeLocalSurfaceMapping(), oofem::FEI3dTetQuad::computeLocalSurfaceMapping(), oofem::FEI3dHexaQuad::computeLocalSurfaceMapping(), oofem::PhaseFieldElement::computeLocationArrayOfDofIDs(), oofem::CoupledFieldsElement::computeLocationArrayOfDofIDs(), oofem::StructuralInterfaceElementPhF::computeLocationArrayOfDofIDs(), oofem::IntElLine1PF::computeLocationArrayOfDofIDs(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::RigidArmNode::computeMasterContribution(), oofem::Line::computeNumberOfIntersectionPoints(), oofem::TR1_2D_CBS::computeNumberOfNodalPrescribedTractionPressureContributions(), oofem::Shell7BaseXFEM::computeOrderingArray(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::WeakPeriodicBoundaryCondition::computeProjectionCoefficient(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::MPlasticMaterial::computeResidualVector(), oofem::MPlasticMaterial2::computeResidualVector(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::Shell7Base::computeStiffnessMatrix(), oofem::Masonry02::computeStrainHardeningVarsIncrement(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::FEInterpolation3d::computeSurfaceMapping(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::InteractionLoad::computeValueAt(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), oofem::ContactElement::ContactElement(), oofem::BoundingBox::contains(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::CylindricalALM::convertHPCMap(), oofem::SparseNonLinearSystemNM::convertPertMap(), oofem::SolutionbasedShapeFunction::copyDofManagersToSurfaceData(), oofem::Shell7Base::CopyIPvaluesToNodes(), oofem::ContactDefinition::createContactDofs(), oofem::Domain::createDofs(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::T3DInterface::createInput(), oofem::FiberedCrossSection::createMaterialStatus(), oofem::Subdivision::createMesh(), oofem::T3DInterface::createQCInterpolationMesh(), oofem::T3DInterface::createVTKExportMesh(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::DelaunayTriangle::DelaunayTriangle(), oofem::ParmetisLoadBalancer::determineDofManState(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::SPRNodalRecoveryModel::determinePatchType(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), oofem::OctantRec::divideLocally(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::divideLocally(), oofem::LEPlic::doInterfaceRemapping(), oofem::PrescribedGradientHomogenization::domainSize(), oofem::TransportGradientPeriodic::domainSize(), oofem::MixedGradientPressureBC::domainSize(), oofem::TransportGradientDirichlet::domainSize(), oofem::PrescribedGenStrainShell7::domainSize(), oofem::DofManExportModule::doOutput(), oofem::VTKExportModule::doOutput(), oofem::VTKXMLExportModule::doOutput(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::MatlabExportModule::doOutputIntegrationPointFields(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::FluidMaterialEvaluator::doStepOutput(), oofem::Subdivision::RS_Triangle::drawGeometry(), oofem::Subdivision::RS_Tetra::drawGeometry(), oofem::drawIGAPatchDeformedGeometry(), oofem::IGAElement::drawRawGeometry(), oofem::QTrPlaneStress2d::drawScalar(), oofem::QPlaneStrain::drawScalar(), oofem::QPlaneStress2d::drawScalar(), oofem::Quad1_ht::drawScalar(), oofem::L4Axisymm::drawScalar(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::Quad1PlaneStrain::drawScalar(), oofem::PlaneStress2d::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::QDKTPlate::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::LSpace::drawTriad(), oofem::FEI2dTrConst::edgeComputeLength(), oofem::FEI2dQuadConst::edgeComputeLength(), oofem::FEI2dTrLin::edgeComputeLength(), oofem::FEI2dQuadLin::edgeComputeLength(), oofem::FEI3dHexaLin::edgeComputeLength(), oofem::FEI3dTetLin::edgeComputeLength(), oofem::FEI2dTrQuad::edgeEvaldNds(), oofem::FEI3dTetLin::edgeEvaldNdx(), oofem::FEI3dHexaQuad::edgeEvaldNdx(), oofem::Shell7Base::edgeEvalInitialCovarBaseVectorsAt(), oofem::Shell7Base::edgeEvalInitialDirectorAt(), oofem::FEI2dTrQuad::edgeEvalNormal(), oofem::FEI2dQuadLin::edgeEvalNormal(), oofem::FEI2dTrLin::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::FEI2dTrLin::edgeLocal2global(), oofem::FEI3dWedgeQuad::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(), enumerate(), oofem::ScalarFunction::eval(), oofem::FEI3dHexaTriQuad::evalNXIntegral(), oofem::FEI2dQuadLin::evalNXIntegral(), oofem::FEI2dTrQuad::evalNXIntegral(), oofem::FEI2dTrLin::evalNXIntegral(), oofem::FEI3dHexaLin::evalNXIntegral(), oofem::FEI3dTetLin::evalNXIntegral(), oofem::FEI2dQuadQuad::evalNXIntegral(), oofem::FEI3dTetQuad::evalNXIntegral(), oofem::FEI3dHexaQuad::evalNXIntegral(), oofem::CalculatorFunction::evaluate(), oofem::EIPrimaryUnknownMapper::evaluateAt(), oofem::InternalVariableField::evaluateAt(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::Subdivision::RS_Triangle::evaluateLongestEdge(), oofem::Subdivision::RS_Tetra::evaluateLongestEdge(), oofem::Subdivision::exchangeSharedEdges(), oofem::VTKExportModule::exportCellVars(), oofem::VTKXMLExportModule::exportCellVars(), oofem::VTKXMLExportModule::exportExternalForces(), oofem::POIExportModule::exportIntVarAs(), oofem::VTKExportModule::exportIntVarAs(), oofem::POIExportModule::exportIntVars(), oofem::VTKExportModule::exportIntVars(), oofem::VTKXMLExportModule::exportIntVars(), oofem::VTKXMLExportModule::exportIntVarsInGpAs(), oofem::POIExportModule::exportPrimaryVars(), oofem::VTKXMLExportModule::exportPrimaryVars(), oofem::VTKExportModule::exportPrimVarAs(), oofem::Skyline::factorized(), oofem::NonlocalMaterialWTP::fastRebuildNonlocalTables(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::Delamination::findInitiationFronts(), findNonzeros(), oofem::FluidModel::forceEquationNumbering(), oofem::EngngModel::forceEquationNumbering(), oofem::SloanLevelStructure::formYourself(), oofem::Subdivision::RS_Triangle::generate(), oofem::Subdivision::RS_Tetra::generate(), oofem::ParticleTopologyDescription::generateMesh(), oofem::PythonExpression::getDict(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::oofegGraphicContext::getMaterialModelFilterState(), oofem::MPlasticMaterial2::getNewPopulation(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::MPlasticMaterial2::getPopulationSignature(), oofem::M1Material::give3dMaterialStiffnessMatrix(), oofem::SpatialLocalizer::giveAllElementsWithNodesWithinBox(), oofem::RefinedElement::giveBcDofArray1D(), oofem::RefinedElement::giveBcDofArray2D(), oofem::RefinedElement::giveBcDofArray3D(), oofem::RefinedElement::giveBoundaryFlagArray(), oofem::RefinedElement::giveBoundaryLoadArray1D(), oofem::RefinedElement::giveBoundaryLoadArray2D(), oofem::RefinedElement::giveBoundaryLoadArray3D(), oofem::Tr2Shell7::giveBoundaryLocationArray(), oofem::Element::giveBoundaryLocationArray(), oofem::VTKPiece::giveCellOffset(), oofem::VTKPiece::giveCellType(), oofem::OctantRec::giveChildContainingPoint(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::giveChildContainingPoint(), oofem::OctreeSpatialLocalizer::giveClosestIPWithinOctant(), oofem::FETIBoundaryDofManager::giveCodeNumber(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::FETIBoundaryDofManager::giveCompleteLocationArray(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::Beam3d::giveCompositeExportData(), oofem::CemhydMat::giveConcreteCapacity(), oofem::CemhydMat::giveConcreteDensity(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::RCM2Material::giveCrackedStiffnessMatrix(), oofem::FCMMaterialStatus::giveCrackStatus(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::VTKXMLExportModule::giveDataHeaders(), oofem::Delamination::giveDelamInterfaceNum(), oofem::Subdivision::RS_Triangle::giveDensity(), oofem::Subdivision::RS_Tetra::giveDensity(), oofem::MITC4Shell::giveDirectorVectors(), oofem::PressureNumberingScheme::giveDofEquationNumber(), oofem::QuasicontinuumNumberingscheme::giveDofEquationNumber(), oofem::ActiveDof::giveDofIDs(), oofem::Element::giveDofManager(), oofem::Element::giveDofManagerNumber(), oofem::CombinedZZSIRemeshingCriteria::giveDofManDensity(), oofem::ZZRemeshingCriteria::giveDofManDensity(), oofem::HuertaRemeshingCriteria::giveDofManDensity(), oofem::ParmetisLoadBalancer::giveDofManState(), oofem::Tr_Warp::giveEdgeDofMapping(), oofem::Structural3DElement::giveEdgeDofMapping(), oofem::LIBeam2d::giveEdgeDofMapping(), oofem::LIBeam2dNL::giveEdgeDofMapping(), oofem::CCTPlate::giveEdgeDofMapping(), oofem::DKTPlate3d::giveEdgeDofMapping(), oofem::Structural2DElement::giveEdgeDofMapping(), oofem::LIBeam3d::giveEdgeDofMapping(), oofem::Truss3d::giveEdgeDofMapping(), oofem::TrPlanestressRotAllman::giveEdgeDofMapping(), oofem::LIBeam3dNL2::giveEdgeDofMapping(), oofem::LIBeam3dNL::giveEdgeDofMapping(), oofem::Truss2d::giveEdgeDofMapping(), oofem::DKTPlate::giveEdgeDofMapping(), oofem::LIBeam3d2::giveEdgeDofMapping(), oofem::PFEMElement2d::giveEdgeDofMapping(), oofem::Subdivision::RS_Triangle::giveEdgeIndex(), oofem::Subdivision::RS_Tetra::giveEdgeIndex(), oofem::EnrichmentItem::giveEIDofIdArray(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::VTKExportModule::giveElementCell(), oofem::VTKXMLExportModule::giveElementCell(), oofem::DummySpatialLocalizer::giveElementClosestToPoint(), oofem::OctreeSpatialLocalizer::giveElementContainingPoint(), oofem::NonlocalMaterialWTP::giveElementNonlocalDepArry(), oofem::ParmetisLoadBalancer::giveElementPartition(), oofem::OctreeSpatialLocalizer::giveElementsWithIPWithinBox(), oofem::ActiveDof::giveEquationNumbers(), oofem::Dof::giveEquationNumbers(), oofem::FiberedCrossSection::giveFiberMaterialStiffnessMatrix(), oofem::OOFEMTXTInputRecord::giveField(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::ParmetisLoadBalancer::giveGlobalElementNumber(), oofem::DofManager::giveInputRecord(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::LayeredCrossSection::giveInterfaceMaterial(), oofem::LayeredCrossSection::giveInterfaceMaterialNum(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::StructuralMaterial::giveInvertedVoigtVectorMask(), oofem::FiberedCrossSection::giveIPValue(), oofem::RCM2Material::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::Subdivision::RS_Element::giveIrregular(), oofem::CemhydMat::giveIsotropicConductivity(), oofem::BSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::IGAElement::giveKnotSpanParallelMode(), oofem::LayeredCrossSection::giveLayerMaterial(), oofem::OctreeSpatialLocalizer::giveListOfTerminalCellsInBoundingBox(), oofem::OctreeSpatialLocalizerT< oofem::UnstructuredGridField::Cell >::giveListOfTerminalCellsInBoundingBox(), oofem::FCMMaterial::giveLocalCrackedStiffnessMatrix(), oofem::DirectErrorIndicatorRC::giveLocalDofManDensity(), oofem::DirectErrorIndicatorRC::giveLocalDofManIndicator(), oofem::ParmetisLoadBalancer::giveLocalElementNumber(), oofem::LinearConstraintBC::giveLocArray(), oofem::Node2NodeContact::giveLocationArray(), oofem::DofManager::giveLocationArray(), oofem::PrescribedGradientBCNeumann::giveLocationArrays(), oofem::SurfaceTensionBoundaryCondition::giveLocationArrays(), oofem::LinearConstraintBC::giveLocationArrays(), oofem::MixedGradientPressureWeakPeriodic::giveLocationArrays(), oofem::MixedGradientPressureNeumann::giveLocationArrays(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::SolutionbasedShapeFunction::giveMasterDof(), oofem::SlaveDof::giveMasterDof(), oofem::ActiveDof::giveMasterDofManArray(), oofem::SimpleSlaveDof::giveMasterDofManArray(), oofem::Dof::giveMasterDofManArray(), oofem::DofManager::giveMasterDofMans(), oofem::LayeredCrossSection::giveMaterial(), oofem::OctreeSpatialLocalizer::giveMaxTreeDepthFrom(), oofem::OctreeSpatialLocalizerT< oofem::UnstructuredGridField::Cell >::giveMaxTreeDepthFrom(), oofem::Subdivision::RS_Element::giveNeighbor(), oofem::Natural2GlobalOrdering::giveNewEq(), oofem::Natural2LocalOrdering::giveNewEq(), oofem::EngngModel::giveNewEquationNumber(), oofem::EngngModel::giveNewPrescribedEquationNumber(), oofem::LEPlic::giveNodalScalarRepresentation(), oofem::DelaunayTriangle::giveNode(), oofem::Subdivision::RS_Element::giveNode(), oofem::Element::giveNode(), oofem::Set::giveNodeList(), oofem::ConnectivityTable::giveNodeNeighbourList(), oofem::OctreeSpatialLocalizer::giveNodesWithinBox(), oofem::FCMMaterialStatus::giveNumberOfCracks(), oofem::EngngModel::giveNumberOfDomainEquations(), oofem::FCMMaterialStatus::giveNumberOfTempCracks(), oofem::OctreeSpatialLocalizer::giveOctreeMaskValue(), oofem::OctreeSpatialLocalizerT< oofem::UnstructuredGridField::Cell >::giveOctreeMaskValue(), oofem::CemhydMatStatus::GivePower(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), oofem::CompoDamageMat::giveRealStressVector(), oofem::LatticeDamage2d::giveRealStressVector(), oofem::M1Material::giveRealStressVector_3d(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::ExportModule::giveRegionSet(), oofem::TR_SHELL02::giveRotationMatrix(), oofem::TR_SHELL01::giveRotationMatrix(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::Subdivision::RS_Element::giveSharedEdge(), oofem::FETIBoundaryDofManager::giveSharedPartition(), oofem::Subdivision::RS_SharedEdge::giveSharedPartitions(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::Shell7Base::giveShellExportData(), oofem::Element::giveSide(), oofem::Subdivision::RS_Triangle::giveSideNodes(), oofem::Subdivision::RS_Tetra::giveSideNodes(), oofem::J2Mat::giveStressBackVector(), oofem::Skyline::giveSubMatrix(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::Tr2Shell7XFEM::giveSurfaceDofMapping(), oofem::Tr2Shell7::giveSurfaceDofMapping(), oofem::TrPlaneStrRot3d::giveSurfaceDofMapping(), oofem::Structural3DElement::giveSurfaceDofMapping(), oofem::CCTPlate3d::giveSurfaceDofMapping(), oofem::QDKTPlate::giveSurfaceDofMapping(), oofem::DKTPlate3d::giveSurfaceDofMapping(), oofem::Quad1PlateSubSoil::giveSurfaceDofMapping(), oofem::Tria1PlateSubSoil::giveSurfaceDofMapping(), oofem::DKTPlate::giveSurfaceDofMapping(), oofem::MITC4Shell::giveSurfaceDofMapping(), oofem::FCMMaterialStatus::giveTempCrackStatus(), oofem::RCM2MaterialStatus::giveTempCrackStatus(), oofem::DofGrouping::giveTotalLocationArray(), oofem::Shell7Base::giveTractionBC(), oofem::DofManager::giveUnknownVectorOfType(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::StructuralMaterial::giveVoigtVectorMask(), oofem::ParmetisLoadBalancer::handleMasterSlaveDofManLinks(), oofem::DynCompRow::ILUPYourself(), oofem::Subdivision::RS_Node::importConnectivity(), oofem::Subdivision::RS_Triangle::importConnectivity(), oofem::Subdivision::RS_Tetra::importConnectivity(), oofem::DummySpatialLocalizer::init(), oofem::PressureNumberingScheme::init(), oofem::QuasicontinuumNumberingscheme::init(), oofem::Natural2GlobalOrdering::init(), oofem::Natural2LocalOrdering::init(), oofem::oofegGraphicContext::init(), oofem::ParmetisLoadBalancer::initGlobalParmetisElementNumbering(), oofem::CompCol_ILUPreconditioner::initialize(), oofem::SlaveDof::initialize(), oofem::BCTracker::initialize(), oofem::SloanGraph::initialize(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::ContactDefinitionNode2Node::initializeFrom(), oofem::IntElLine1::initializeFrom(), oofem::Delamination::initializeFrom(), oofem::StationaryTransportProblem::initializeFrom(), oofem::IGAElement::initializeFrom(), oofem::ContactDefinitionNode2NodeL::initializeFrom(), oofem::Lattice2d::initializeFrom(), oofem::Lattice2d_mt::initializeFrom(), oofem::TransientTransportProblem::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::IGATSplineElement::initializeFrom(), oofem::StaggeredSolver::initializeFrom(), oofem::BSplineInterpolation::initializeFrom(), oofem::Beam2d::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::Beam3d::initializeFrom(), oofem::Load::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::PointSwarm::initializeFrom(), oofem::DofManager::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::ListBasedEI::initiateFronts(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::NRSolver::initPrescribedEqs(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::VTKExportModule::initRegionNodeNumbering(), oofem::VTKXMLExportModule::initRegionNodeNumbering(), oofem::RCM2MaterialStatus::initTempStatus(), oofem::DynCompRow::insertColInRow(), oofem::OctreeSpatialLocalizer::insertElementIntoOctree(), oofem::OctreeSpatialLocalizer::insertElementsUsingNodalConnectivitiesIntoOctree(), oofem::DynCompCol::insertRowInColumn(), oofem::ConnectivityTable::instanciateConnectivityTable(), oofem::Delamination::instanciateYourself(), oofem::PolylineNonlocalBarrier::isActivated(), oofem::Skyline::isAllocatedAt(), oofem::RCM2MaterialStatus::isCrackActive(), oofem::Load::isDofExcluded(), oofem::DofManager::isLocal(), oofem::Subdivision::RS_Triangle::isNeighborOf(), oofem::Subdivision::RS_Tetra::isNeighborOf(), oofem::Subdivision::isNodeLocalIrregular(), oofem::Subdivision::isNodeLocalSharedIrregular(), oofem::ParmetisLoadBalancer::labelDofManagers(), oofem::Skyline::ldl_feti_sky(), oofem::Tet1_3D_SUPG::LS_PCS_computeF(), oofem::TR21_2D_SUPG::LS_PCS_computeF(), oofem::Quad10_2D_SUPG::LS_PCS_computeF(), oofem::TR1_2D_SUPG::LS_PCS_computeF(), oofem::Tet1_3D_SUPG::LS_PCS_computeS(), oofem::TR21_2D_SUPG::LS_PCS_computeS(), oofem::TR1_2D_SUPG::LS_PCS_computeS(), oofem::VTKXMLExportModule::makeFullTensorForm(), oofem::Natural2GlobalOrdering::map2New(), oofem::Natural2LocalOrdering::map2New(), oofem::Natural2GlobalOrdering::map2Old(), oofem::Natural2LocalOrdering::map2Old(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::EnrichmentFront::MarkTipElementNodesAsFront(), oofem::FETISolver::masterMapDirectionVector(), oofem::FETISolver::masterMapGammas(), oofem::FETISolver::masterMapPPVector(), oofem::FETISolver::masterMapQQProduct(), oofem::FETISolver::masterMapRBM(), oofem::FETISolver::masterMapResiduals(), oofem::FETISolver::masterMapSolution(), oofem::FETISolver::masterUnpackQQProduct(), oofem::FETISolver::masterUnpackRBM(), oofem::DofManager::mergePartitionList(), oofem::TriangleMesherInterface::meshPSLG(), oofem::NonlocalMaterialWTP::migrate(), oofem::LoadBalancer::migrateLoad(), oofem::MDM::MMI_map(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::tet21ghostsolid::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Hexa21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Tet21Stokes::NodalAveragingRecoveryMI_computeNodalValue(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_showSparseMtrxStructure(), oofem::Subdivision::RS_Node::numberSharedEdges(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputMesh(), oofem::GnuplotExportModule::outputReactionForces(), oofem::FETISolver::packDirectionVector(), oofem::EngngModel::packDofManagers(), oofem::FETISolver::packGammas(), oofem::Subdivision::packIrregularSharedGlobnums(), oofem::FETISolver::packPPVector(), oofem::FETISolver::packRBM(), oofem::EngngModel::packRemoteElementData(), oofem::Subdivision::packRemoteElements(), oofem::FETISolver::packResiduals(), oofem::NodalAveragingRecoveryModel::packSharedDofManData(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::SPRNodalRecoveryModel::packSharedDofManData(), oofem::DirectErrorIndicatorRC::packSharedDofManLocalDensities(), oofem::DirectErrorIndicatorRC::packSharedDofManLocalIndicatorVals(), oofem::Subdivision::packSharedEdges(), oofem::Subdivision::packSharedIrregulars(), oofem::FETISolver::packSolution(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::Tr_Warp::postInitialize(), oofem::RCSDEMaterialStatus::printOutputAt(), oofem::RCSDMaterialStatus::printOutputAt(), oofem::M1MaterialStatus::printOutputAt(), oofem::FCMMaterialStatus::printOutputAt(), oofem::RCM2MaterialStatus::printOutputAt(), oofem::EngngModel::printOutputAt(), oofem::StructuralEngngModel::printReactionForces(), oofem::NRSolver::printState(), printYourself(), oofem::ListBasedEI::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::PLnodeRadius::propagateInterface(), oofem::ProblemCommunicator::quickSortPartition(), oofem::quickSortPartition(), oofem::Skyline::rbmodes(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), oofem::LevelSetPCS::redistance(), oofem::RefinedMesh::refineMeshGlobally(), oofem::REGISTER_EnrichmentFront(), oofem::ParticleTopologyDescription::replaceFEMesh(), oofem::SlaveDof::restoreContext(), oofem::Element::restoreContext(), oofem::FiberedCrossSection::restoreIPContext(), oofem::LayeredCrossSection::restoreIPContext(), oofem::SlaveDof::saveContext(), oofem::Element::saveContext(), oofem::FiberedCrossSection::saveIPContext(), oofem::LayeredCrossSection::saveIPContext(), oofem::QClinearStatic::setActivatedElementList(), oofem::QClinearStatic::setActivatedNodeList(), oofem::oofegGraphicContext::setActiveProblem(), oofem::VTKPiece::setCellType(), oofem::FETIBoundaryDofManager::setCodeNumbers(), oofem::GradDpElement::setDisplacementLocationArray(), oofem::SkylineUnsym::setInternalStructure(), oofem::Skyline::setInternalStructure(), oofem::Subdivision::RS_Element::setIrregular(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::BoundingBox::setMask(), oofem::oofegGraphicContext::setMaterialModelFilterState(), oofem::Subdivision::RS_Element::setNeighbor(), oofem::GradDpElement::setNonlocalLocationArray(), oofem::EngngModel::setNumberOfEquations(), oofem::VTKPiece::setOffset(), oofem::Subdivision::RS_Element::setSharedEdge(), oofem::FCMMaterialStatus::setTempCrackStatus(), oofem::RCM2MaterialStatus::setTempCrackStatus(), oofem::FETICommunicator::setUpCommunicationMaps(), oofem::FETISolver::setUpCommunicationMaps(), oofem::NodeCommunicator::setUpCommunicationMaps(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::Shell7Base::setupInitialEdgeSolutionVector(), oofem::Quasicontinuum::setupInterpolationMesh(), oofem::LayeredIntegrationRule::SetUpPointsOnWedge(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::QuasicontinuumVTKXMLExportModule::setupVTKPiece(), oofem::VTKXMLExportModule::setupVTKPiece(), oofem::StructuralElement::showSparseMtrxStructure(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::ErrorEstimator::skipRegion(), oofem::Subdivision::smoothMesh(), oofem::FreemInterface::smoothNodalDensities(), oofem::InverseIteration::solve(), oofem::FETISolver::solve(), oofem::NRSolver::solve(), oofem::CylindricalALM::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::DEIDynamic::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), oofem::Q27Space::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::CCTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::DKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Q27Space::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::CCTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::DKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quasicontinuum::stiffnessAssignment(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dTetLin::surfaceEvaldNdx(), oofem::FEI3dTetQuad::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEI3dHexaTriQuad::surfaceEvalNormal(), oofem::FEI3dTetLin::surfaceEvalNormal(), oofem::FEI3dHexaLin::surfaceEvalNormal(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::FEI3dHexaQuad::surfaceEvalNormal(), oofem::FEI3dHexaLin::surfaceLocal2global(), oofem::FEI3dTetLin::surfaceLocal2global(), oofem::FEI3dWedgeQuad::surfaceLocal2global(), oofem::FEI3dWedgeLin::surfaceLocal2global(), oofem::FEI3dHexaQuad::surfaceLocal2global(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::Skyline::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::Skyline::toFloatMatrix(), oofem::TR1_2D_PFEM::TR1_2D_PFEM(), oofem::QClinearStatic::transformMeshToParticles(), oofem::Quasicontinuum::transformStiffnessTensorToMatrix(), oofem::SloanGraph::tryParameters(), oofem::Communicator::unpackAllData(), oofem::FETISolver::unpackDirectionVector(), oofem::EngngModel::unpackDofManagers(), oofem::Subdivision::unpackIrregularSharedGlobnums(), oofem::FETISolver::unpackPPVector(), oofem::EngngModel::unpackRemoteElementData(), oofem::NonlocalMaterialWTP::unpackRemoteElements(), oofem::Subdivision::unpackRemoteElements(), oofem::FETISolver::unpackResiduals(), oofem::NodalAveragingRecoveryModel::unpackSharedDofManData(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::SPRNodalRecoveryModel::unpackSharedDofManData(), oofem::DirectErrorIndicatorRC::unpackSharedDofManLocalDensities(), oofem::DirectErrorIndicatorRC::unpackSharedDofManLocalIndicatorVals(), oofem::Subdivision::unpackSharedEdges(), oofem::Subdivision::unpackSharedIrregulars(), oofem::FETISolver::unpackSolution(), oofem::Subdivision::RS_Triangle::update_neighbours(), oofem::Subdivision::RS_Tetra::update_neighbours(), oofem::RCM2Material::updateActiveCrackMap(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::FreeWarping::updateComputedResults(), oofem::RCM2Material::updateCrackStatus(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::Set::updateLocalElementNumbering(), oofem::Set::updateLocalNodeNumbering(), oofem::SlaveNode::updateLocalNumbering(), oofem::SlaveDof::updateLocalNumbering(), oofem::XfemManager::updateNodeEnrichmentItemMap(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::LevelSetPCS::updatePosition(), oofem::NodalRecoveryModel::updateRegionRecoveredValues(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::FreeWarping::updateStiffnessMatrix(), oofem::FCMMaterialStatus::updateYourself(), oofem::VTKXMLExportModule::writeCellVars(), oofem::VTKXMLExportModule::writeExternalForces(), oofem::VTKXMLExportModule::writeIntVars(), oofem::SloanGraph::writeOptimalRenumberingTable(), oofem::VTKXMLExportModule::writePrimaryVars(), oofem::VTKXMLExportModule::writeVTKPiece(), oofem::VTKXMLExportModule::writeXFEMVars(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix(), and oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay().

int oofem::IntArray::at ( int  i) const
inline

Coefficient access function.

Returns value of coefficient at given position of the receiver.

Parameters
iposition of coefficient in array.
Returns
Value at position.

Definition at line 114 of file intarray.h.

std::vector< int >:: iterator oofem::IntArray::begin ( )
inline

Definition at line 70 of file intarray.h.

Referenced by oofem::Set::hasElement(), oofem::InverseIteration::solve(), and sort().

std::vector< int >:: const_iterator oofem::IntArray::begin ( ) const
inline

Definition at line 72 of file intarray.h.

void oofem::IntArray::clear ( )
inline

Clears the array (zero size).

Definition at line 177 of file intarray.h.

Referenced by oofem::MMALeastSquareProjection::__init(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::Skyline::buildInternalStructure(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::Set::clear(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::PhaseFieldElement::computeLocationArrayOfDofIDs(), oofem::Shell7BaseXFEM::computeOrderingArray(), oofem::ContactElement::ContactElement(), oofem::XfemManager::createEnrichedDofs(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::ErrorEstimator::ErrorEstimator(), oofem::Subdivision::RS_Triangle::generate(), oofem::Subdivision::RS_Tetra::generate(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::SpatialLocalizer::giveAllElementsWithNodesWithinBox(), oofem::Element::giveBoundaryLocationArray(), oofem::ActiveDof::giveDofIDs(), oofem::SlaveDof::giveDofIDs(), oofem::ContactElement::giveDofManagersToAppendTo(), oofem::HTSelement::giveDofManDofIDMask(), oofem::Element::giveDofManDofIDMask(), oofem::StructuralElement::giveEdgeDofMapping(), oofem::NonlocalMaterialWTP::giveElementNonlocalDepArry(), oofem::ActiveDof::giveEquationNumbers(), oofem::SlaveDof::giveEquationNumbers(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::Element::giveInternalDofManDofIDMask(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::DofManager::giveLocationArray(), oofem::Element::giveLocationArray(), oofem::StructuralElement::giveMassMtrxIntegrationgMask(), oofem::StructuralElementEvaluator::giveMassMtrxIntegrationMask(), oofem::DofManager::giveMasterDofIDArray(), oofem::SlaveDof::giveMasterDofManArray(), oofem::DofManager::giveMasterDofMans(), oofem::StructuralElement::giveNonlocalLocationArray(), oofem::EnrichmentItem::givePotentialEIDofIdArray(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::StructuralElement::giveSurfaceDofMapping(), oofem::DofGrouping::giveTotalLocationArray(), oofem::TracSegArray::giveTractionLocationArray(), oofem::PrescribedGradientBCWeak::giveTractionLocationArray(), oofem::StructuralMaterial::giveVoigtSymVectorMask(), oofem::OutputExportModule::initializeFrom(), oofem::TSplineInterpolation::initializeFrom(), oofem::PrescribedMean::initializeFrom(), oofem::Set::initializeFrom(), oofem::WallClockLoadBalancerMonitor::initializeFrom(), oofem::TransientTransportProblem::initializeFrom(), oofem::ExportModule::initializeFrom(), oofem::MixedGradientPressureWeakPeriodic::initializeFrom(), oofem::InitialCondition::initializeFrom(), oofem::ErrorEstimator::initializeFrom(), oofem::SparseNonLinearSystemNM::initializeFrom(), oofem::StaggeredProblem::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::GeneralBoundaryCondition::initializeFrom(), oofem::NRSolver::initializeFrom(), oofem::ErrorCheckingExportModule::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::DofManager::initializeFrom(), oofem::Element::initializeFrom(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::EngngModel::Instanciate_init(), oofem::ParmetisLoadBalancer::labelDofManagers(), oofem::LinearConstraintBC::LinearConstraintBC(), oofem::MacroLSpace::MacroLSpace(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::MicroMaterial::MicroMaterial(), oofem::MixedGradientPressureDirichlet::MixedGradientPressureDirichlet(), oofem::OctreeSpatialLocalizer::OctreeSpatialLocalizer(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::PLCZdamageRadius::propagateInterface(), oofem::PLnodeRadius::propagateInterface(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::Subdivision::RS_SharedEdge::removePartitions(), oofem::Set::restoreContext(), oofem::Quasicontinuum::setupInterpolationMesh(), oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), and oofem::Quasicontinuum::stiffnessAssignment().

bool oofem::IntArray::contains ( int  value) const
inline
Returns
True if receiver contains given value.

Definition at line 283 of file intarray.h.

References oofem::sort().

Referenced by oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::LinearConstraintBC::assemble(), oofem::LinearConstraintBC::assembleVector(), oofem::MacroLSpace::changeMicroBoundaryConditions(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::CompoDamageMat::checkSnapBack(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::DofIDEquationNumbering::giveDofEquationNumber(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::FCMMaterialStatus::giveMaxNumberOfCracks(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Subdivision::RS_SharedEdge::giveSharedPartitions(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::StructuralMaterialEvaluator::initializeFrom(), oofem::FluidMaterialEvaluator::initializeFrom(), oofem::DofManager::initializeFrom(), oofem::Subdivision::RS_Triangle::numberSharedEdges(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::Subdivision::packIrregularSharedGlobnums(), oofem::NonlocalMaterialWTP::packRemoteElements(), oofem::Subdivision::packRemoteElements(), oofem::Subdivision::packSharedEdges(), oofem::Subdivision::packSharedIrregulars(), oofem::PLCZdamageRadius::propagateInterface(), oofem::MicroMaterial::setMacroProperties(), and oofem::RCM2Material::updateCrackStatus().

bool oofem::IntArray::containsOnlyZeroes ( ) const
bool oofem::IntArray::containsSorted ( int  value) const
inline

Checks if sorted receiver contains a given value.

Returns
True if receiver contains given value.

Definition at line 238 of file intarray.h.

Referenced by oofem::TransportGradientDirichlet::computeXi(), and oofem::CrackExportModule::doOutput().

std::vector< int >:: iterator oofem::IntArray::end ( )
inline

Definition at line 71 of file intarray.h.

Referenced by oofem::Set::hasElement(), oofem::InverseIteration::solve(), and sort().

std::vector< int >:: const_iterator oofem::IntArray::end ( ) const
inline

Definition at line 73 of file intarray.h.

void oofem::IntArray::erase ( int  pos)

Erase the element at given position (1-based index) Receiver will shrink accordingly, the values at positions (pos+1,...,size) will be moved to positions (pos,...,size-1)

Parameters
posPosition to erase.

Definition at line 163 of file intarray.C.

References values.

Referenced by oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), and oofem::DofManager::removePartitionFromList().

void oofem::IntArray::eraseSorted ( int  value)

Erase the element of given value.

If the value is found receiver will shrink accordingly, while preserving a sorted state.

Parameters
valueValue to erase.

Definition at line 374 of file intarray.C.

References values.

Referenced by oofem::Subdivision::RS_Node::eraseConnectedElement().

int oofem::IntArray::findCommonValuesSorted ( const IntArray iarray,
IntArray common,
int  allocChunk = 0 
) const

Extracts common values in receiver and iarray.

Assumes that receiver as well as iarray are sorted. The size of array common is changed accordingly.

Parameters
iarrayArray to search for values common with receiver.
commonArray of common values.
allocChunkIf reallocation needed, an additional space for allocChunk values will be allocated.
Returns
Number of common values.

Definition at line 383 of file intarray.C.

References followedBy(), giveSize(), and values.

Referenced by oofem::Subdivision::RS_Tetra::bisect(), oofem::Subdivision::exchangeSharedEdges(), oofem::XfemManager::initiateFronts(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::Delamination::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::Subdivision::unpackIrregularSharedGlobnums(), oofem::Subdivision::unpackSharedEdges(), and oofem::Subdivision::unpackSharedIrregulars().

int oofem::IntArray::findFirstIndexOf ( int  value) const

Finds index of first occurrence of given value in array.

Parameters
valueScanned value.
Returns
Index of first value in array, otherwise zero.

Definition at line 331 of file intarray.C.

References values.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMAShapeFunctProjection::__mapVariable(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::RigidArmNode::computeMasterContribution(), oofem::Load::computeValues(), oofem::Subdivision::RS_Element::containsNode(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::WallClockLoadBalancerMonitor::decide(), oofem::LoadBalancer::deleteRemoteDofManagers(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::Subdivision::RS_Triangle::generate(), oofem::Subdivision::RS_Tetra::generate(), oofem::PrescribedGradient::give(), oofem::BoundaryCondition::give(), oofem::PrescribedGradientBCPeriodic::giveBcValue(), oofem::TransportGradientPeriodic::giveBcValue(), oofem::MixedGradientPressureDirichlet::giveBcValue(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::DummySpatialLocalizer::giveElementContainingPoint(), oofem::OctreeSpatialLocalizer::giveElementContainingPoint(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), oofem::Natural2LocalOrdering::giveOldEq(), oofem::DofManager::givePartitionsConnectivitySize(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::MixedGradientPressureDirichlet::giveUnknown(), insertOnce(), oofem::MMAShapeFunctProjection::mapVariable(), oofem::TriangleMesherInterface::meshPSLG(), oofem::LoadBalancer::packMigratingData(), oofem::ParmetisLoadBalancer::packSharedDmanPartitions(), oofem::DofManager::removePartitionFromList(), oofem::Subdivision::RS_Tetra::RS_Tetra(), oofem::Subdivision::RS_Triangle::RS_Triangle(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::Subdivision::smoothMesh(), oofem::ExportModule::testDomainOutput(), and oofem::Subdivision::RS_Tetra::update_neighbours().

void oofem::IntArray::findNonzeros ( const IntArray logical)

Finds all indices where the input array is nonzero.

Parameters
logicalArray of logical values (0 = false, nonzero = true) to have index extracted.

Definition at line 206 of file intarray.C.

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

Referenced by oofem::Set::computeIntArray(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::Set::giveNodeList(), and oofem::DofGrouping::giveTotalLocationArray().

int oofem::IntArray::findSorted ( int  value) const

Finds the first occurrence of given value, assuming that the receiver is sorted.

Returns
Index (1-based), if not present, 0 is returned.

Definition at line 344 of file intarray.C.

References values.

Referenced by oofem::OctreeSpatialLocalizer::giveElementsWithIPWithinBox(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), and oofem::XfemManager::initiateFronts().

void oofem::IntArray::followedBy ( const IntArray b,
int  allocChunk = 0 
)

Appends array b at the end of receiver.

Parameters
bArray to be appended at the end of receiver
allocChunkIf reallocation needed, an additional space for allocChunk values will be allocated to prevent excessive reallocation.

Definition at line 145 of file intarray.C.

References giveSize(), and values.

Referenced by oofem::MMALeastSquareProjection::__init(), oofem::FETIBoundaryDofManager::addPartition(), oofem::Subdivision::RS_SharedEdge::addPartition(), oofem::PrescribedGradientBCWeak::assembleExtraDisplock(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::PhaseFieldElement::computeLocationArrayOfDofIDs(), oofem::CoupledFieldsElement::computeLocationArrayOfDofIDs(), oofem::StructuralInterfaceElementPhF::computeLocationArrayOfDofIDs(), oofem::TransportGradientDirichlet::computeXi(), oofem::ContactElement::ContactElement(), oofem::XfemManager::createEnrichedDofs(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::MatlabExportModule::doOutputReactionForces(), findCommonValuesSorted(), oofem::SloanLevelStructure::formYourself(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::Element::giveBoundaryLocationArray(), oofem::DofManager::giveCompleteLocationArray(), oofem::DofManager::giveCompleteMasterDofIDArray(), oofem::ActiveDof::giveDofIDs(), oofem::SlaveDof::giveDofIDs(), oofem::PlaneStress2dXfem::giveDofManDofIDMask(), oofem::TrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::QTrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::Shell7BaseXFEM::giveDofManDofIDMask(), oofem::XfemManager::giveEnrichedDofIDs(), oofem::ActiveDof::giveEquationNumbers(), oofem::SlaveDof::giveEquationNumbers(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::DofManager::giveInputRecord(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::TSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::Node2NodeContactL::giveLocationArray(), oofem::DofManager::giveLocationArray(), oofem::Element::giveLocationArray(), oofem::DofManager::giveMasterDofIDArray(), oofem::ActiveDof::giveMasterDofManArray(), oofem::SlaveDof::giveMasterDofManArray(), oofem::StructuralElement::giveNonlocalLocationArray(), oofem::EnrichmentItem::givePotentialEIDofIdArray(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::Subdivision::RS_SharedEdge::giveSharedPartitions(), oofem::DofGrouping::giveTotalLocationArray(), oofem::TracSegArray::giveTractionLocationArray(), oofem::PrescribedGradientBCWeak::giveTractionLocationArray(), oofem::PrescribedMean::initializeFrom(), oofem::StructuralMaterialEvaluator::initializeFrom(), oofem::FluidMaterialEvaluator::initializeFrom(), oofem::MixedGradientPressureWeakPeriodic::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::XfemManager::initiateFronts(), insertOnce(), oofem::Delamination::instanciateYourself(), oofem::MixedGradientPressureDirichlet::MixedGradientPressureDirichlet(), oofem::MixedGradientPressureNeumann::MixedGradientPressureNeumann(), oofem::MixedGradientPressureWeakPeriodic::MixedGradientPressureWeakPeriodic(), oofem::MDM::MMI_map(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::Subdivision::RS_Triangle::numberSharedEdges(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::PrescribedGradientBCNeumann::PrescribedGradientBCNeumann(), oofem::PrescribedGradientBCPeriodic::PrescribedGradientBCPeriodic(), oofem::Delamination::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::MicroMaterial::setMacroProperties(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::VTKXMLExportModule::setupVTKPiece(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::TransportGradientNeumann::TransportGradientNeumann(), and oofem::TransportGradientPeriodic::TransportGradientPeriodic().

void oofem::IntArray::followedBy ( int  b,
int  allocChunk = 0 
)

Appends given Number at the end of receiver.

Parameters
bvalue to be appended.
allocChunkIf reallocation needed, an additional space for allocChunk values will be allocated to prevent excessive reallocation.

Definition at line 154 of file intarray.C.

References giveSize(), and values.

int oofem::IntArray::givePackSize ( DataStream buff) const

Returns how much space is needed to pack receivers message.

Parameters
buffBuffer used for packing.

Definition at line 325 of file intarray.C.

References oofem::DataStream::givePackSizeOfInt(), and giveSize().

Referenced by oofem::ElementCommunicator::setUpCommunicationMaps().

int* oofem::IntArray::givePointer ( )
inline

Definition at line 337 of file intarray.h.

References oofem::operator<<().

int oofem::IntArray::giveSize ( ) const
inline
Returns
Size of receiver.

Definition at line 203 of file intarray.h.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMAShapeFunctProjection::__init(), oofem::MMALeastSquareProjection::__init(), add(), oofem::Quasicontinuum::addCrosssectionToInterpolationElements(), oofem::Element::addDofManager(), oofem::Quasicontinuum::applyApproach1(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::NRSolver::applyConstraintsToLoadIncrement(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedMean::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::SkylineUnsym::assemble(), oofem::PetscSparseMtrx::assemble(), oofem::DynCompRow::assemble(), oofem::DynCompCol::assemble(), oofem::LinearConstraintBC::assemble(), oofem::SymCompCol::assemble(), oofem::Skyline::assemble(), oofem::CompCol::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::PrescribedGradientBCWeak::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::FloatMatrix::assemble(), oofem::FloatArray::assemble(), oofem::FloatArray::assembleSquared(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::LinearConstraintBC::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::EngngModel::assembleVectorFromElements(), oofem::FloatArray::beSubArrayOf(), oofem::FloatMatrix::beSubMatrixOf(), oofem::Subdivision::RS_Triangle::bisect(), oofem::Subdivision::RS_Tetra::bisect(), oofem::SkylineUnsym::buildInternalStructure(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::DynCompRow::buildInternalStructure(), oofem::DynCompCol::buildInternalStructure(), oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::Subdivision::RS_Node::buildTopLevelNodeConnectivity(), oofem::Subdivision::RS_Element::buildTopLevelNodeConnectivity(), oofem::PolylineNonlocalBarrier::calculateMinimumDistanceFromBoundary(), oofem::MacroLSpace::changeMicroBoundaryConditions(), oofem::ReactionErrorCheckingRule::check(), oofem::LumpedMassElement::checkConsistency(), oofem::FiberedCrossSection::checkConsistency(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::RowColumn::checkSizeTowards(), oofem::SkylineUnsym::checkSizeTowards(), oofem::DynCompRow::checkSizeTowards(), oofem::DynCompCol::checkSizeTowards(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::TR1_2D_SUPG_AXI::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCLhsTerm_MB(), oofem::SUPGElement::computeBCLhsTerm_MB(), oofem::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::TransportElement::computeBCSubMtrxAt(), oofem::TransportElement::computeBCSubVectorAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::Element::computeBoundaryVectorOf(), oofem::LineDistributedSpring::computeConstitutiveMatrixAt(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::CylindricalALM::computeDeltaLambda(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::Element::computeDofTransformationMatrix(), oofem::PrescribedMean::computeDomainSize(), oofem::FEInterpolation2d::computeEdgeMapping(), oofem::FEInterpolation3d::computeEdgeMapping(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::EnrichmentItem::computeEnrichedDofManDofIdArray(), oofem::TransportGradientNeumann::computeEta(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::Hexa21Stokes::computeExternalForcesVector(), oofem::Tet21Stokes::computeExternalForcesVector(), oofem::Tr21Stokes::computeExternalForcesVector(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::Line2BoundaryElement::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::Set::computeIntArray(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::Node::computeL2GTransformation(), oofem::DofManager::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::PhaseFieldElement::computeLocationArrayOfDofIDs(), oofem::CoupledFieldsElement::computeLocationArrayOfDofIDs(), oofem::StructuralInterfaceElementPhF::computeLocationArrayOfDofIDs(), oofem::IntElLine1PF::computeLocationArrayOfDofIDs(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::RigidArmNode::computeMasterContribution(), oofem::Structural3DElement::computeNumberOfDofs(), oofem::LumpedMassElement::computeNumberOfDofs(), oofem::LineDistributedSpring::computeNumberOfDofs(), oofem::Structural2DElement::computeNumberOfDofs(), oofem::NodalSpringElement::computeNumberOfDofs(), oofem::Line::computeNumberOfIntersectionPoints(), oofem::TR1_2D_CBS::computeNumberOfNodalPrescribedTractionPressureContributions(), oofem::Shell7BaseXFEM::computeOrderingArray(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::Shell7Base::computeStiffnessMatrix(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::LineDistributedSpring::computeStressVector(), oofem::FEInterpolation3d::computeSurfaceMapping(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::ElementSide::computeTransformation(), oofem::InteractionLoad::computeValueAt(), oofem::Load::computeValues(), oofem::Element::computeVectorOf(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::Element::computeVectorOfPrescribed(), oofem::SloanLevelStructure::computeWidth(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), oofem::ContactElement::ContactElement(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::CylindricalALM::convertHPCMap(), oofem::SparseNonLinearSystemNM::convertPertMap(), oofem::SolutionbasedShapeFunction::copyDofManagersToSurfaceData(), oofem::ContactDefinition::createContactDofs(), oofem::Domain::createDofs(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::Subdivision::createMesh(), oofem::WallClockLoadBalancerMonitor::decide(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::SPRNodalRecoveryModel::determinePatchType(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), oofem::LEPlic::doInterfaceRemapping(), oofem::PrescribedGradientHomogenization::domainSize(), oofem::TransportGradientNeumann::domainSize(), oofem::TransportGradientPeriodic::domainSize(), oofem::MixedGradientPressureBC::domainSize(), oofem::TransportGradientDirichlet::domainSize(), oofem::PrescribedGenStrainShell7::domainSize(), oofem::DofManExportModule::doOutput(), oofem::GPExportModule::doOutput(), oofem::VTKExportModule::doOutput(), oofem::MatlabExportModule::doOutput(), oofem::VTKXMLExportModule::doOutput(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::MatlabExportModule::doOutputIntegrationPointFields(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::FluidMaterialEvaluator::doStepOutput(), oofem::drawIGAPatchDeformedGeometry(), oofem::Shell7Base::edgeEvalInitialCovarBaseVectorsAt(), oofem::Shell7Base::edgeEvalInitialDirectorAt(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::ScalarFunction::eval(), oofem::TSplineInterpolation::evaldNdx(), oofem::TSplineInterpolation::evalN(), oofem::CalculatorFunction::evaluate(), oofem::EIPrimaryUnknownMapper::evaluateAt(), oofem::UniformGridField::evaluateAt(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::Subdivision::exchangeSharedEdges(), oofem::VTKExportModule::exportCellVars(), oofem::VTKXMLExportModule::exportCellVars(), oofem::VTKXMLExportModule::exportExternalForces(), oofem::POIExportModule::exportIntVars(), oofem::VTKExportModule::exportIntVars(), oofem::VTKXMLExportModule::exportIntVars(), oofem::VTKXMLExportModule::exportIntVarsInGpAs(), oofem::POIExportModule::exportPrimaryVars(), oofem::VTKXMLExportModule::exportPrimaryVars(), findCommonValuesSorted(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::ParticleTopologyDescription::findDisplacement(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::Delamination::findInitiationFronts(), findNonzeros(), followedBy(), oofem::Subdivision::RS_Triangle::generate(), oofem::Subdivision::RS_Tetra::generate(), oofem::ParticleTopologyDescription::generateMesh(), oofem::ParticleTopologyDescription::generatePSLG(), oofem::PythonExpression::getDict(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::oofegGraphicContext::getMaterialModelFilterState(), oofem::MPlasticMaterial2::getNewPopulation(), oofem::VTKXMLExportModule::getNodalVariableFromIS(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::MPlasticMaterial2::getPopulationSignature(), oofem::M1Material::give3dMaterialStiffnessMatrix(), oofem::SpatialLocalizer::giveAllElementsWithNodesWithinBox(), oofem::Tr2Shell7::giveBoundaryLocationArray(), oofem::Element::giveBoundaryLocationArray(), oofem::DynCompRow::giveColIndx(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::Beam3d::giveCompositeExportData(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::VTKXMLExportModule::giveDataHeaders(), oofem::Domain::giveDefaultNodeDofIDArry(), oofem::MITC4Shell::giveDirectorVectors(), oofem::Element::giveDofManager(), oofem::CombinedZZSIRemeshingCriteria::giveDofManDensity(), oofem::ZZRemeshingCriteria::giveDofManDensity(), oofem::HuertaRemeshingCriteria::giveDofManDensity(), oofem::Crack::giveDofPoolSize(), oofem::EnrichmentItem::giveDofPoolSize(), oofem::Structural3DElement::giveEdgeDofMapping(), oofem::Structural2DElement::giveEdgeDofMapping(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::EnrichmentItem::giveEIDofIdArray(), oofem::VTKXMLExportModule::giveElementCell(), oofem::DummySpatialLocalizer::giveElementClosestToPoint(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::CBSElement::giveInputRecord(), oofem::NonlocalMaterialExtensionInterface::giveInputRecord(), oofem::DofManager::giveInputRecord(), oofem::Element::giveInputRecord(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::StructuralMaterial::giveInvertedVoigtVectorMask(), oofem::TSplineInterpolation::giveJacobianMatrixAt(), oofem::FCMMaterial::giveLocalCrackedStiffnessMatrix(), oofem::DirectErrorIndicatorRC::giveLocalDofManDensity(), oofem::DirectErrorIndicatorRC::giveLocalDofManIndicator(), oofem::Node2NodeContact::giveLocationArray(), oofem::DofManager::giveLocationArray(), oofem::PrescribedGradientBCNeumann::giveLocationArrays(), oofem::SurfaceTensionBoundaryCondition::giveLocationArrays(), oofem::TransportGradientNeumann::giveLocationArrays(), oofem::MixedGradientPressureWeakPeriodic::giveLocationArrays(), oofem::MixedGradientPressureNeumann::giveLocationArrays(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::DofManager::giveMasterDofMans(), oofem::LEPlic::giveNodalScalarRepresentation(), oofem::Element::giveNode(), oofem::Set::giveNodeList(), oofem::ConnectivityTable::giveNodeNeighbourList(), oofem::FCMMaterialStatus::giveNumberOfCracks(), oofem::Shell7BaseXFEM::giveNumberOfDofs(), oofem::DofManager::giveNumberOfPrimaryMasterDofs(), oofem::ExportModule::giveNumberOfRegions(), oofem::FCMMaterialStatus::giveNumberOfTempCracks(), oofem::UnstructuredGridField::Cell::giveNumberOfVertices(), givePackSize(), oofem::DofManager::givePartitionsConnectivitySize(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::DofManager::givePrescribedUnknownVector(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::StructuralMaterial::giveReducedSymVectorForm(), oofem::DynCompCol::giveRowIndx(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::Subdivision::RS_SharedEdge::giveSharedPartitions(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::Shell7Base::giveShellExportData(), oofem::Element::giveSide(), oofem::StructuralMaterial::giveSizeOfVoigtSymVector(), oofem::StructuralMaterial::giveSizeOfVoigtVector(), oofem::J2Mat::giveStressBackVector(), oofem::PetscSparseMtrx::giveSubMatrix(), oofem::Skyline::giveSubMatrix(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::Structural3DElement::giveSurfaceDofMapping(), oofem::DofGrouping::giveTotalLocationArray(), oofem::Shell7Base::giveTractionBC(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::DofManager::giveUnknownVector(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::ParmetisLoadBalancer::handleMasterSlaveDofManLinks(), oofem::CompCol_ICPreconditioner::ICFactor(), oofem::DynCompRow::ILUPYourself(), oofem::Subdivision::RS_Node::importConnectivity(), oofem::Subdivision::RS_Triangle::importConnectivity(), oofem::Subdivision::RS_Tetra::importConnectivity(), oofem::QuasicontinuumNumberingscheme::init(), oofem::ParticleGrid< Point >::init(), oofem::Natural2GlobalOrdering::init(), oofem::OctreeSpatialLocalizer::initElementDataStructure(), oofem::CompCol_ILUPreconditioner::initialize(), oofem::SlaveDof::initialize(), oofem::BCTracker::initialize(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::MacroLSpace::initializeFrom(), oofem::TwoFluidMaterial::initializeFrom(), oofem::SlaveNode::initializeFrom(), oofem::TSplineInterpolation::initializeFrom(), oofem::ActiveBoundaryCondition::initializeFrom(), oofem::LineDistributedSpring::initializeFrom(), oofem::ContactDefinitionNode2Node::initializeFrom(), oofem::SymmetryBarrier::initializeFrom(), oofem::Delamination::initializeFrom(), oofem::StructuralMaterialEvaluator::initializeFrom(), oofem::CohesiveSurface3d::initializeFrom(), oofem::StationaryTransportProblem::initializeFrom(), oofem::RigidArmNode::initializeFrom(), oofem::LinearConstraintBC::initializeFrom(), oofem::WallClockLoadBalancerMonitor::initializeFrom(), oofem::NodalSpringElement::initializeFrom(), oofem::ContactDefinitionNode2NodeL::initializeFrom(), oofem::IGAElement::initializeFrom(), oofem::TransientTransportProblem::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::BoundaryCondition::initializeFrom(), oofem::IGATSplineElement::initializeFrom(), oofem::StaggeredSolver::initializeFrom(), oofem::CemhydMat::initializeFrom(), oofem::BSplineInterpolation::initializeFrom(), oofem::Beam2d::initializeFrom(), oofem::SparseNonLinearSystemNM::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::FiberedCrossSection::initializeFrom(), oofem::NRSolver::initializeFrom(), oofem::Beam3d::initializeFrom(), oofem::Load::initializeFrom(), oofem::AbaqusUserElement::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::PointSwarm::initializeFrom(), oofem::NonlocalMaterialExtensionInterface::initializeFrom(), oofem::DofManager::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::LoadBalancer::initializeWtp(), oofem::ListBasedEI::initiateFronts(), oofem::XfemManager::initiateFronts(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::VTKXMLExportModule::initRegionNodeNumbering(), oofem::DynCompRow::insertColInRow(), oofem::DynCompCol::insertRowInColumn(), oofem::Delamination::instanciateYourself(), oofem::ParticleTopologyDescription::instanciateYourself(), oofem::PolylineNonlocalBarrier::isActivated(), oofem::Load::isDofExcluded(), oofem::DofManager::isLocal(), oofem::Subdivision::isNodeLocalIrregular(), oofem::Subdivision::isNodeLocalSharedIrregular(), oofem::ParmetisLoadBalancer::labelDofManagers(), oofem::TSplineInterpolation::local2global(), oofem::Natural2GlobalOrdering::map2New(), oofem::Natural2LocalOrdering::map2New(), oofem::Natural2GlobalOrdering::map2Old(), oofem::Natural2LocalOrdering::map2Old(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::EnrichmentFront::MarkTipElementNodesAsFront(), oofem::FETISolver::masterMapDirectionVector(), oofem::FETISolver::masterMapPPVector(), oofem::FETISolver::masterMapRBM(), oofem::FETISolver::masterMapResiduals(), oofem::FETISolver::masterMapSolution(), oofem::FETISolver::masterUnpackRBM(), oofem::DofManager::mergePartitionList(), oofem::TriangleMesherInterface::meshPSLG(), oofem::NonlocalMaterialWTP::migrate(), oofem::LoadBalancer::migrateLoad(), oofem::UniformGridField::nodeValue2d(), oofem::UniformGridField::nodeValue3d(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_showSparseMtrxStructure(), oofem::Subdivision::RS_Node::numberSharedEdges(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::ParticleGridIterator< Point >::operator++(), oofem::operator<<(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputMesh(), oofem::GnuplotExportModule::outputReactionForces(), oofem::FETISolver::packDirectionVector(), oofem::EngngModel::packDofManagers(), oofem::FETISolver::packPPVector(), oofem::FETISolver::packRBM(), oofem::EngngModel::packRemoteElementData(), oofem::FETISolver::packResiduals(), oofem::NodalAveragingRecoveryModel::packSharedDofManData(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::SPRNodalRecoveryModel::packSharedDofManData(), oofem::DirectErrorIndicatorRC::packSharedDofManLocalDensities(), oofem::DirectErrorIndicatorRC::packSharedDofManLocalIndicatorVals(), oofem::FETISolver::packSolution(), oofem::EngngModel::printOutputAt(), oofem::StructuralEngngModel::printReactionForces(), oofem::DynCompCol::printStatistics(), oofem::OctantRec::printYourself(), printYourself(), printYourselfToFile(), oofem::ListBasedEI::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::PLnodeRadius::propagateInterface(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::REGISTER_EnrichmentFront(), oofem::ParticleTopologyDescription::replaceFEMesh(), oofem::Element::saveContext(), oofem::QClinearStatic::setActivatedElementList(), oofem::QClinearStatic::setActivatedNodeList(), oofem::qcNode::setAsHanging(), oofem::UniformGridField::setGeometry(), oofem::SkylineUnsym::setInternalStructure(), oofem::Skyline::setInternalStructure(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::MicroMaterial::setMacroProperties(), oofem::oofegGraphicContext::setMaterialModelFilterState(), oofem::FETICommunicator::setUpCommunicationMaps(), oofem::FETISolver::setUpCommunicationMaps(), oofem::NodeCommunicator::setUpCommunicationMaps(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::Shell7Base::setupInitialEdgeSolutionVector(), oofem::Quasicontinuum::setupInterpolationMesh(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::QuasicontinuumVTKXMLExportModule::setupVTKPiece(), oofem::VTKXMLExportModule::setupVTKPiece(), oofem::UniformGridField::setValues(), oofem::StructuralElement::showSparseMtrxStructure(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::ErrorEstimator::skipRegion(), oofem::Subdivision::smoothMesh(), oofem::FreemInterface::smoothNodalDensities(), oofem::CylindricalALM::solve(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::DEIDynamic::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::sort(), oofem::ProblemCommunicator::sortCommMap(), oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), storeYourself(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dTetLin::surfaceEvaldNdx(), oofem::FEI3dTetQuad::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEI3dWedgeQuad::surfaceEvalNormal(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::PetscSparseMtrx::toFloatMatrix(), oofem::Skyline::toFloatMatrix(), oofem::FETISolver::unpackDirectionVector(), oofem::EngngModel::unpackDofManagers(), oofem::Subdivision::unpackIrregularSharedGlobnums(), oofem::FETISolver::unpackPPVector(), oofem::EngngModel::unpackRemoteElementData(), oofem::FETISolver::unpackResiduals(), oofem::NodalAveragingRecoveryModel::unpackSharedDofManData(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::SPRNodalRecoveryModel::unpackSharedDofManData(), oofem::DirectErrorIndicatorRC::unpackSharedDofManLocalDensities(), oofem::DirectErrorIndicatorRC::unpackSharedDofManLocalIndicatorVals(), oofem::Subdivision::unpackSharedEdges(), oofem::Subdivision::unpackSharedIrregulars(), oofem::FETISolver::unpackSolution(), oofem::Subdivision::RS_Triangle::update_neighbours(), oofem::Subdivision::RS_Tetra::update_neighbours(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::Set::updateLocalElementNumbering(), oofem::Set::updateLocalNodeNumbering(), oofem::SlaveNode::updateLocalNumbering(), oofem::XfemManager::updateNodeEnrichmentItemMap(), oofem::LevelSetPCS::updatePosition(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::FCMMaterialStatus::updateYourself(), oofem::VTKXMLExportModule::writeCellVars(), oofem::VTKXMLExportModule::writeExternalForces(), oofem::VTKXMLExportModule::writeIntVars(), oofem::SloanGraph::writeOptimalRenumberingTable(), oofem::VTKXMLExportModule::writePrimaryVars(), oofem::VTKXMLExportModule::writeVTKPiece(), oofem::VTKXMLExportModule::writeXFEMVars(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), and oofem::UniformGridField::xyz2ijk().

void oofem::IntArray::insertOnce ( int  p)

Insert once (does not make any assumption about receiver state or ordering, quite inefficient).

More efficient version insertSortedOnce exist.

Parameters
pValue to insert.

Definition at line 412 of file intarray.C.

References findFirstIndexOf(), and followedBy().

Referenced by oofem::SolutionbasedShapeFunction::initializeSurfaceData(), and oofem::DofManager::mergePartitionList().

void oofem::IntArray::insertSorted ( int  value,
int  allocChunk = 0 
)

Inserts given value into a receiver, which is assumed to be sorted.

The size of receiver is changed accordingly.

Parameters
valuevalue to insert.
allocChunkIf reallocation needed, an additional space for allocChunk values will be allocated.

Definition at line 350 of file intarray.C.

References values.

Referenced by oofem::Subdivision::RS_Node::importConnectivity(), oofem::Subdivision::RS_Node::insertConnectedElement(), oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), and oofem::ListBasedEI::updateNodeEnrMarker().

bool oofem::IntArray::insertSortedOnce ( int  value,
int  allocChunk = 0 
)
bool oofem::IntArray::isEmpty ( ) const
inline
bool oofem::IntArray::isFinite ( ) const

Returns true if no element is NAN or infinite.

Definition at line 258 of file intarray.C.

References values.

int oofem::IntArray::maximum ( ) const

Finds the maximum component in the array.

Returns
Maximum of array or prints error is array is empty.

Definition at line 195 of file intarray.C.

References isEmpty(), OOFEM_ERROR, and values.

Referenced by oofem::FloatArray::beSubArrayOf(), oofem::FloatMatrix::beSubMatrixOf(), oofem::Set::computeIntArray(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), and oofem::ParticleTopologyDescription::replaceFEMesh().

int oofem::IntArray::minimum ( ) const

Finds the minimum component in the array.

Returns
Minimum of array or prints error is array is empty.

Definition at line 184 of file intarray.C.

References isEmpty(), OOFEM_ERROR, and values.

Referenced by oofem::FloatArray::beSubArrayOf(), oofem::FloatMatrix::beSubMatrixOf(), and oofem::ParallelOrdering::isLocal().

int& oofem::IntArray::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.
Returns
Value at position.

Definition at line 125 of file intarray.h.

Referenced by add().

const int& oofem::IntArray::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.
Returns
Value at position.

Definition at line 136 of file intarray.h.

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

Assignment operator.

Definition at line 88 of file intarray.h.

References values.

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

Move operator.

Definition at line 90 of file intarray.h.

IntArray& oofem::IntArray::operator= ( std::initializer_list< int >  list)
inline

Assignment operator.

Definition at line 92 of file intarray.h.

int& oofem::IntArray::operator[] ( int  i)
inline

Definition at line 142 of file intarray.h.

Referenced by add().

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

Definition at line 148 of file intarray.h.

void oofem::IntArray::printYourself ( const std::string  name) const

Prints receiver on stdout with custom name.

Parameters
nameDisplay name of reciever.

Definition at line 242 of file intarray.C.

References at(), and giveSize().

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

Print receiver to file.

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

Definition at line 273 of file intarray.C.

References giveSize(), and OOFEM_ERROR.

void oofem::IntArray::pY ( ) const

Abbreviation for printYourself().

Definition at line 269 of file intarray.C.

References printYourself().

void oofem::IntArray::resize ( int  n)

Checks size of receiver towards requested bounds.

Data is always zeroed.

Parameters
nNew size of array.

Definition at line 124 of file intarray.C.

References values.

Referenced by oofem::MMALeastSquareProjection::__init(), oofem::AdaptiveNonLinearStatic::adaptiveRemap(), oofem::Delamination::appendInputRecords(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::FEInterpolation2d::boundarySurfaceGiveNodes(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::Skyline::buildInternalStructure(), oofem::SymCompCol::buildInternalStructure(), oofem::CompCol::buildInternalStructure(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::StructuralEngngModel::buildReactionTable(), oofem::ParmetisLoadBalancer::calculateLoadTransfer(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::CompoDamageMatStatus::CompoDamageMatStatus(), oofem::PrescribedMean::computeDomainSize(), oofem::FEInterpolation2d::computeEdgeMapping(), oofem::FEInterpolation3d::computeEdgeMapping(), oofem::EnrichmentItem::computeEnrichedDofManDofIdArray(), oofem::FEI2dQuadConst::computeLocalEdgeMapping(), oofem::FEI2dTrConst::computeLocalEdgeMapping(), oofem::FEI2dQuadLin::computeLocalEdgeMapping(), oofem::FEI2dTrQuad::computeLocalEdgeMapping(), oofem::FEI2dTrLin::computeLocalEdgeMapping(), oofem::FEI3dTetLin::computeLocalEdgeMapping(), oofem::FEI2dQuadQuad::computeLocalEdgeMapping(), oofem::FEI3dTetQuad::computeLocalEdgeMapping(), oofem::FEI3dTrQuad::computeLocalEdgeMapping(), oofem::FEI3dTetLin::computeLocalSurfaceMapping(), oofem::FEI3dTetQuad::computeLocalSurfaceMapping(), oofem::FEI3dHexaQuad::computeLocalSurfaceMapping(), oofem::CoupledFieldsElement::computeLocationArrayOfDofIDs(), oofem::StructuralInterfaceElementPhF::computeLocationArrayOfDofIDs(), oofem::IntElLine1PF::computeLocationArrayOfDofIDs(), oofem::RigidArmNode::computeMasterContribution(), oofem::Shell7BaseXFEM::computeOrderingArray(), oofem::FEInterpolation3d::computeSurfaceMapping(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::ContactElement::ContactElement(), oofem::CylindricalALM::convertHPCMap(), oofem::SparseNonLinearSystemNM::convertPertMap(), oofem::T3DInterface::createInput(), oofem::Subdivision::createMesh(), oofem::T3DInterface::createQCInterpolationMesh(), oofem::T3DInterface::createVTKExportMesh(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::LEPlic::doLagrangianPhase(), oofem::HOMExportModule::doOutput(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::HuertaErrorEstimator::estimateError(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::ExportModule::ExportModule(), oofem::NonlocalMaterialWTP::fastRebuildNonlocalTables(), oofem::FCMMaterialStatus::FCMMaterialStatus(), oofem::SloanLevelStructure::formYourself(), oofem::Subdivision::RS_Triangle::generate(), oofem::Subdivision::RS_Tetra::generate(), oofem::ParticleTopologyDescription::generatePSLG(), oofem::ParticleGrid< Point >::getBoundingBox(), oofem::MPlasticMaterial2::getNewPopulation(), oofem::ParticleGrid< Point >::getPosition(), oofem::RefinedElement::giveBcDofArray1D(), oofem::RefinedElement::giveBcDofArray2D(), oofem::RefinedElement::giveBcDofArray3D(), oofem::RefinedElement::giveBoundaryFlagArray(), oofem::RefinedElement::giveBoundaryLoadArray1D(), oofem::RefinedElement::giveBoundaryLoadArray2D(), oofem::RefinedElement::giveBoundaryLoadArray3D(), oofem::Tr2Shell7::giveBoundaryLocationArray(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::FETIBoundaryDofManager::giveCompleteLocationArray(), oofem::DofManager::giveCompleteLocationArray(), oofem::ActiveDof::giveDofIDs(), oofem::Tr_Warp::giveEdgeDofMapping(), oofem::Structural3DElement::giveEdgeDofMapping(), oofem::LIBeam2d::giveEdgeDofMapping(), oofem::LIBeam2dNL::giveEdgeDofMapping(), oofem::CCTPlate::giveEdgeDofMapping(), oofem::DKTPlate3d::giveEdgeDofMapping(), oofem::Structural2DElement::giveEdgeDofMapping(), oofem::LIBeam3d::giveEdgeDofMapping(), oofem::Truss3d::giveEdgeDofMapping(), oofem::TrPlanestressRotAllman::giveEdgeDofMapping(), oofem::LIBeam3dNL2::giveEdgeDofMapping(), oofem::LIBeam3dNL::giveEdgeDofMapping(), oofem::Truss2d::giveEdgeDofMapping(), oofem::DKTPlate::giveEdgeDofMapping(), oofem::LIBeam3d2::giveEdgeDofMapping(), oofem::PFEMElement2d::giveEdgeDofMapping(), oofem::EnrichmentItem::giveEIDofIdArray(), oofem::VTKExportModule::giveElementCell(), oofem::VTKXMLExportModule::giveElementCell(), oofem::ConnectivityTable::giveElementNeighbourList(), oofem::NonlocalMaterialWTP::giveElementNonlocalDepArry(), oofem::ActiveDof::giveEquationNumbers(), oofem::Dof::giveEquationNumbers(), oofem::OOFEMTXTInputRecord::giveField(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::StructuralMaterial::giveInvertedVoigtVectorMask(), oofem::BSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::LinearConstraintBC::giveLocArray(), oofem::Node2NodeContact::giveLocationArray(), oofem::DofManager::giveLocationArray(), oofem::PrescribedGradientBCNeumann::giveLocationArrays(), oofem::SurfaceTensionBoundaryCondition::giveLocationArrays(), oofem::TransportGradientNeumann::giveLocationArrays(), oofem::MixedGradientPressureWeakPeriodic::giveLocationArrays(), oofem::MixedGradientPressureNeumann::giveLocationArrays(), oofem::ActiveDof::giveMasterDofManArray(), oofem::SimpleSlaveDof::giveMasterDofManArray(), oofem::Dof::giveMasterDofManArray(), oofem::ConnectivityTable::giveNodeNeighbourList(), oofem::ParticleGrid< Point >::givePosition(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Subdivision::RS_Triangle::giveSideNodes(), oofem::Subdivision::RS_Tetra::giveSideNodes(), oofem::Tr2Shell7XFEM::giveSurfaceDofMapping(), oofem::Tr2Shell7::giveSurfaceDofMapping(), oofem::TrPlaneStrRot3d::giveSurfaceDofMapping(), oofem::Structural3DElement::giveSurfaceDofMapping(), oofem::CCTPlate3d::giveSurfaceDofMapping(), oofem::QDKTPlate::giveSurfaceDofMapping(), oofem::DKTPlate3d::giveSurfaceDofMapping(), oofem::Tria1PlateSubSoil::giveSurfaceDofMapping(), oofem::Quad1PlateSubSoil::giveSurfaceDofMapping(), oofem::DKTPlate::giveSurfaceDofMapping(), oofem::MITC4Shell::giveSurfaceDofMapping(), oofem::DofGrouping::giveTotalLocationArray(), oofem::StructuralMaterial::giveVoigtVectorMask(), oofem::DynCompCol::growTo(), oofem::DynCompRow::ILUPYourself(), oofem::Subdivision::RS_Triangle::importConnectivity(), oofem::Subdivision::RS_Tetra::importConnectivity(), oofem::PressureNumberingScheme::init(), oofem::QuasicontinuumNumberingscheme::init(), oofem::Natural2GlobalOrdering::init(), oofem::Natural2LocalOrdering::init(), oofem::oofegGraphicContext::init(), oofem::ParmetisLoadBalancer::initGlobalParmetisElementNumbering(), oofem::CompCol_ICPreconditioner::initialize(), oofem::CompCol_ILUPreconditioner::initialize(), oofem::SlaveDof::initialize(), oofem::SloanGraph::initialize(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::InterpolatingFuction::initializeFrom(), oofem::MacroLSpace::initializeFrom(), oofem::IGAElement::initializeFrom(), oofem::Lattice2d::initializeFrom(), oofem::Lattice2d_mt::initializeFrom(), oofem::MatlabExportModule::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::IGATSplineElement::initializeFrom(), oofem::CemhydMat::initializeFrom(), oofem::BSplineInterpolation::initializeFrom(), oofem::StaggeredProblem::initializeFrom(), oofem::Load::initializeFrom(), oofem::XfemManager::initiateFronts(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::NRSolver::initPrescribedEqs(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::VTKExportModule::initRegionNodeNumbering(), oofem::VTKXMLExportModule::initRegionNodeNumbering(), oofem::EngngModel::Instanciate_init(), oofem::ParticleTopologyDescription::instanciateYourself(), oofem::ParmetisLoadBalancer::labelDofManagers(), oofem::Natural2GlobalOrdering::map2New(), oofem::Natural2LocalOrdering::map2New(), oofem::Natural2GlobalOrdering::map2Old(), oofem::Natural2LocalOrdering::map2Old(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::TriangleMesherInterface::meshPSLG(), oofem::MDM::MMI_map(), oofem::NonlocalMaterialExtensionInterface::NonlocalMaterialExtensionInterface(), oofem::AbaqusUserElement::postInitialize(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::RefinedElement::RefinedElement(), oofem::RefinedMesh::refineMeshGlobally(), oofem::SlaveDof::restoreContext(), oofem::Subdivision::RS_Tetra::RS_Tetra(), oofem::Subdivision::RS_Triangle::RS_Triangle(), oofem::oofegGraphicContext::setActiveProblem(), oofem::FETIBoundaryDofManager::setCodeNumbers(), oofem::GradDpElement::setDisplacementLocationArray(), oofem::SkylineUnsym::setInternalStructure(), oofem::GradDpElement::setNonlocalLocationArray(), oofem::FETISolver::setUpCommunicationMaps(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::Quasicontinuum::setupInterpolationMesh(), oofem::LayeredIntegrationRule::SetUpPointsOnWedge(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::Subdivision::smoothMesh(), oofem::FETISolver::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::Q27Space::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::CCTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::DKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Q27Space::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::CCTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::DKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QClinearStatic::transformMeshToParticles(), oofem::SloanGraph::tryParameters(), oofem::NonlocalMaterialWTP::unpackRemoteElements(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::Tr2Shell7XFEM::updateIntegrationRuleMultiCrack(), and oofem::UniformGridField::xyz2ijk().

void oofem::IntArray::resizeWithValues ( int  n,
int  allocChunk = 0 
)

Checks size of receiver towards requested bounds.

If dimension mismatch, size is adjusted accordingly and memory is copied over.

Parameters
nNew size of array.
allocChunkIf reallocation needed, an additional space for allocChunk values will be allocated to prevent excessive reallocation.

Definition at line 115 of file intarray.C.

References values.

Referenced by oofem::Element::addDofManager(), oofem::StructuralEngngModel::buildReactionTable(), oofem::DofManager::giveCompleteLocationArray(), oofem::DofManager::giveCompleteMasterDofIDArray(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::DynCompRow::ILUPYourself(), oofem::DynCompRow::insertColInRow(), oofem::DynCompCol::insertRowInColumn(), oofem::Tr_Warp::postInitialize(), and oofem::SolutionbasedShapeFunction::setLoads().

void oofem::IntArray::zero ( )

Sets all component to zero.

Definition at line 52 of file intarray.C.

References values.

Referenced by oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::OctreeSpatialLocalizer::buildOctreeDataStructure(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::OctreeSpatialLocalizerT< oofem::UnstructuredGridField::Cell >::clear(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::CompoDamageMatStatus::CompoDamageMatStatus(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::Set::computeIntArray(), oofem::ContactElement::ContactElement(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::HuertaErrorEstimator::estimateError(), oofem::FCMMaterialStatus::FCMMaterialStatus(), oofem::MPlasticMaterial2::getNewPopulation(), oofem::DKTPlate3d::giveEdgeDofMapping(), oofem::StructuralMaterial::giveInvertedVoigtVectorMask(), oofem::Node2NodeContact::giveLocationArray(), oofem::Set::giveNodeList(), oofem::TrPlaneStrRot3d::giveSurfaceDofMapping(), oofem::CCTPlate3d::giveSurfaceDofMapping(), oofem::QDKTPlate::giveSurfaceDofMapping(), oofem::DKTPlate3d::giveSurfaceDofMapping(), oofem::Quad1PlateSubSoil::giveSurfaceDofMapping(), oofem::Tria1PlateSubSoil::giveSurfaceDofMapping(), oofem::DKTPlate::giveSurfaceDofMapping(), oofem::MITC4Shell::giveSurfaceDofMapping(), oofem::Subdivision::RS_Triangle::importConnectivity(), oofem::Subdivision::RS_Tetra::importConnectivity(), oofem::DummySpatialLocalizer::init(), oofem::QuasicontinuumNumberingscheme::init(), oofem::Natural2GlobalOrdering::init(), oofem::OctreeSpatialLocalizer::init(), oofem::InterpolatingFuction::initializeFrom(), oofem::Lattice2d::initializeFrom(), oofem::Lattice2d_mt::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::CemhydMat::initializeFrom(), oofem::Load::initializeFrom(), oofem::NonlocalMaterialExtensionInterface::initializeFrom(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::VTKExportModule::initRegionNodeNumbering(), oofem::VTKXMLExportModule::initRegionNodeNumbering(), oofem::ConnectivityTable::instanciateConnectivityTable(), oofem::ParticleTopologyDescription::instanciateYourself(), oofem::ParmetisLoadBalancer::labelDofManagers(), oofem::Lattice2d::Lattice2d(), oofem::Lattice2d_mt::Lattice2d_mt(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::Subdivision::RS_Tetra::RS_Tetra(), oofem::Subdivision::RS_Triangle::RS_Triangle(), oofem::SkylineUnsym::setInternalStructure(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::Subdivision::smoothMesh(), oofem::FETISolver::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), and oofem::HuertaErrorEstimator::solveRefinedWholeProblem().

Friends And Related Function Documentation

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

Definition at line 426 of file intarray.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:36 for OOFEM by doxygen 1.8.11 written by Dimitri van Heesch, © 1997-2011