|
OOFEM 3.0
|
#include <intarray.h>
Private Attributes | |
| std::vector< int > | values |
| Stored values. | |
Iterator for for-each loops: | |
| typedef int | Scalar |
| static constexpr int | Dim = 1 |
| std::vector< int >::iterator | begin () |
| std::vector< int >::iterator | end () |
| std::vector< int >::const_iterator | begin () const |
| std::vector< int >::const_iterator | end () const |
| IntArray (int n=0) | |
| Constructor for sized array. Data is zeroed. | |
| IntArray (const IntArray &src) | |
| Copy constructor. Creates the array from another array. | |
| IntArray (IntArray &&src) noexcept | |
| Move constructor. Creates the array from another array. | |
| IntArray (std ::initializer_list< int >list) | |
| Initializer list constructor. | |
| ~IntArray () | |
| Destructor. | |
| IntArray & | operator= (const IntArray &src) |
| Assignment operator. | |
| IntArray & | operator= (IntArray &&src) noexcept |
| Move operator. | |
| IntArray & | operator= (std ::initializer_list< int >list) |
| Assignment operator. | |
| int & | at (std::size_t i) |
| int | at (std::size_t i) const |
| int & | operator() (std::size_t i) |
| int & | operator[] (std::size_t i) |
| const int & | operator() (std::size_t i) const |
| const int & | operator[] (std::size_t i) const |
| void | checkBounds (std::size_t i) const |
| void | resizeWithValues (int n, int allocChunk=0) |
| void | resize (int n) |
| void | clear () |
| void | preallocate (int futureSize) |
| void | enumerate (int maxVal) |
| void | followedBy (const IntArray &b, int allocChunk=0) |
| void | followedBy (int b, int allocChunk=0) |
| int | giveSize () const |
| std::size_t | size () const |
| bool | isEmpty () const |
| bool | containsOnlyZeroes () const |
| int | findSorted (int value) const |
| int | minimum () const |
| int | maximum () const |
| void | findNonzeros (const IntArray &logical) |
| bool | containsSorted (int value) const |
| void | insertSorted (int value, int allocChunk=0) |
| bool | insertSortedOnce (int value, int allocChunk=0) |
| void | eraseSorted (int value) |
| int | findCommonValuesSorted (const IntArray &iarray, IntArray &common, int allocChunk=0) const |
| int | findFirstIndexOf (int value) const |
| bool | contains (int value) const |
| void | insertOnce (int p) |
| void | sort () |
| void | erase (int pos) |
| void | add (int val) |
| void | zero () |
| Sets all component to zero. | |
| void | printYourself () const |
| Prints receiver on stdout. | |
| void | pY () const |
| Abbreviation for printYourself(). | |
| void | printYourself (const std::string name) const |
| void | printYourselfToFile (const std::string filename, const bool showDimensions=true) const |
| bool | isAllFinite () const |
| Returns true if no element is NAN or infinite. | |
| const int * | givePointer () const |
| int * | givePointer () |
| contextIOResultType | storeYourself (DataStream &stream) const |
| contextIOResultType | restoreYourself (DataStream &stream) |
| int | givePackSize (DataStream &buff) const |
| std::vector< int > | minusOne () const |
| std::ostream & | operator<< (std ::ostream &out, const IntArray &x) |
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.
Definition at line 62 of file intarray.h.
| typedef int oofem::IntArray::Scalar |
Definition at line 78 of file intarray.h.
|
inline |
Constructor for sized array. Data is zeroed.
Definition at line 81 of file intarray.h.
References values.
Referenced by findCommonValuesSorted(), findNonzeros(), followedBy(), IntArray(), IntArray(), operator<<, operator=(), operator=(), and operator=().
|
inline |
Copy constructor. Creates the array from another array.
Definition at line 83 of file intarray.h.
References IntArray(), and values.
|
inlinenoexcept |
Move constructor. Creates the array from another array.
Definition at line 85 of file intarray.h.
References IntArray(), and values.
|
inline |
|
inline |
Destructor.
Definition at line 89 of file intarray.h.
| void oofem::IntArray::add | ( | int | val | ) |
Adds given scalar to all values of receiver
| val | Value to add. |
Definition at line 58 of file intarray.C.
References values.
Referenced by oofem::PetscSparseMtrx::giveSubMatrix(), and oofem::PetscSparseMtrx::toFloatMatrix().
|
inline |
Coefficient access function. Returns l-value of coefficient at given position of the receiver.
| i | Position of coefficient in array. |
Definition at line 104 of file intarray.h.
References checkBounds(), and values.
Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMALeastSquareProjection::__init(), oofem::MMAShapeFunctProjection::__init(), oofem::FETIBoundaryDofManager::addPartition(), oofem::QuadraticInterpolation::allocateDofMans(), oofem::Delamination::appendInputRecords(), oofem::DynCompCol::assemble(), oofem::DynCompCol::assemble(), oofem::DynCompRow::assemble(), oofem::FloatArray::assemble(), oofem::FloatMatrix::assemble(), oofem::FloatMatrix::assemble(), oofem::LinearConstraintBC::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::PetscSparseMtrx::assemble(), oofem::PetscSparseMtrx::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedMean::assemble(), oofem::Skyline::assemble(), oofem::Skyline::assemble(), oofem::SkylineUnsym::assemble(), oofem::SkylineUnsym::assemble(), oofem::SpoolesSparseMtrx::assemble(), oofem::SpoolesSparseMtrx::assemble(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::TransverseReinfConstraint::assemble(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnTransferStress(), oofem::FloatArray::assembleSquared(), oofem::FloatMatrix::assembleT(), oofem::LinearConstraintBC::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::TransverseReinfConstraint::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromElements(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorStress(), oofem::FloatArray::beSubArrayOf(), oofem::FloatMatrix::beSubMatrixOf(), oofem::Subdivision::RS_Tetra::bisect(), oofem::DynCompRow::buildInternalStructure(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::Skyline::buildInternalStructure(), oofem::SkylineUnsym::buildInternalStructure(), oofem::StructuralEngngModel::buildReactionTable(), oofem::ConnectivityTable::buildSharedBoundaryEntities(), oofem::Subdivision::RS_Node::buildTopLevelNodeConnectivity(), oofem::ReactionErrorCheckingRule::check(), oofem::Node::checkConsistency(), oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::RowColumn::checkSizeTowards(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::computeAlgorithmicModuli(), oofem::MPlasticMaterial::computeAlgorithmicModuli(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::MDM::computeDamageOnPlane(), oofem::Element::computeDofTransformationMatrix(), oofem::PrescribedMean::computeDomainSize(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::FEInterpolation2d::computeEdgeMapping(), oofem::FEInterpolation3d::computeEdgeMapping(), oofem::EnrichmentItem::computeEnrichedDofManDofIdArray(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::Lattice3dBoundary::computeGeometryProperties(), oofem::Lattice3dBoundaryTruss::computeGeometryProperties(), oofem::LatticeBeam3dBoundary::computeGeometryProperties(), oofem::LatticeLink3dBoundary::computeGeometryProperties(), oofem::Set::computeIntArray(), oofem::PrescribedDispSlipBCNeumannRC::computeInterfaceLength(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::Node::computeL2GTransformation(), oofem::LatticeNeumannCouplingNode::computeLoadCouplingContribution(), oofem::CoupledFieldsElement::computeLocationArrayOfDofIDs(), oofem::IntElLine1PF::computeLocationArrayOfDofIDs(), oofem::PhaseFieldElement::computeLocationArrayOfDofIDs(), oofem::StructuralInterfaceElementPhF::computeLocationArrayOfDofIDs(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::RigidArmNode::computeMasterContribution(), oofem::Line::computeNumberOfIntersectionPoints(), oofem::Shell7BaseXFEM::computeOrderingArray(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::PrescribedDispSlipBCNeumannRC::computeRebarDyad(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsLamGradient(), oofem::Masonry02::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::MPlasticMaterial2::computeResidualVector(), oofem::MPlasticMaterial::computeResidualVector(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::Masonry02::computeStrainHardeningVarsIncrement(), oofem::Lattice3dBoundary::computeStrainVector(), oofem::Lattice3dBoundaryTruss::computeStrainVector(), oofem::LatticeLink3dBoundary::computeStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::FEInterpolation3d::computeSurfaceMapping(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::BondLink3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundary::computeTransformationMatrix(), oofem::LIBeam3dBoundaryBeam::computeTransformationMatrix(), oofem::LIBeam3dBoundaryMembrane::computeTransformationMatrix(), oofem::LIBeam3dBoundaryPlate::computeTransformationMatrix(), oofem::LIBeam3dBoundaryTruss::computeTransformationMatrix(), oofem::LIBeam3dBoundaryVoigt::computeTransformationMatrix(), oofem::LTRSpaceBoundary::computeTransformationMatrix(), oofem::LTRSpaceBoundaryBeam::computeTransformationMatrix(), oofem::LTRSpaceBoundaryMembrane::computeTransformationMatrix(), oofem::LTRSpaceBoundaryPlate::computeTransformationMatrix(), oofem::LTRSpaceBoundaryTruss::computeTransformationMatrix(), oofem::LTRSpaceBoundaryVoigt::computeTransformationMatrix(), oofem::LatticeDirichletCouplingNode::computeUnknownCouplingContribution(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::PrescribedDispSlipBCNeumannRC::computeWeightMatrix(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), oofem::DGProblem::constructBoundaryEntities(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::CylindricalALM::convertHPCMap(), oofem::SolutionbasedShapeFunction::copyDofManagersToSurfaceData(), oofem::Shell7Base::CopyIPvaluesToNodes(), oofem::Domain::createDofs(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::T3DInterface::createInput(), oofem::Subdivision::createMesh(), oofem::T3DInterface::createQCInterpolationMesh(), oofem::T3DInterface::createVTKExportMesh(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::SPRNodalRecoveryModel::determinePatchType(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), oofem::OctantRec::divideLocally(), oofem::OctantRecT< T > *::divideLocally(), oofem::LEPlic::doInterfaceRemapping(), oofem::MixedGradientPressureBC::domainSize(), oofem::PrescribedDispSlipHomogenization::domainSize(), oofem::PrescribedGenStrainShell7::domainSize(), oofem::PrescribedGradientHomogenization::domainSize(), oofem::TransportGradientDirichlet::domainSize(), oofem::TransportGradientPeriodic::domainSize(), oofem::DofManExportModule::doOutput(), oofem::VTKExportModule::doOutput(), oofem::VTKXMLExportModule::doOutput(), oofem::VTKXMLXFemExportModule::doOutput(), oofem::VTKXMLLatticeExportModule::doOutputNormal(), oofem::Lattice3dBoundary::drawDeformedGeometry(), oofem::Lattice3dBoundaryTruss::drawDeformedGeometry(), oofem::LatticeBeam3dBoundary::drawDeformedGeometry(), oofem::LatticeLink3dBoundary::drawDeformedGeometry(), oofem::StructuralElementEvaluator::drawIGAPatchDeformedGeometry, oofem::IGAElement::drawRawGeometry(), oofem::Lattice3dBoundary::drawRawGeometry(), oofem::Lattice3dBoundaryTruss::drawRawGeometry(), oofem::LatticeBeam3dBoundary::drawRawGeometry(), oofem::LatticeLink3dBoundary::drawRawGeometry(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::L4Axisymm::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::PlaneStress2d::drawScalar(), oofem::QDKTPlate::drawScalar(), oofem::QPlaneStrain::drawScalar(), oofem::QPlaneStress2d::drawScalar(), oofem::QTrPlaneStress2d::drawScalar(), oofem::Quad1_ht::drawScalar(), oofem::Quad1PlaneStrain::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::LSpace::drawTriad(), oofem::FEI2dQuadConst::edgeComputeLength(), oofem::FEI2dQuadLin::edgeComputeLength(), oofem::FEI2dTrConst::edgeComputeLength(), oofem::FEI2dTrLin::edgeComputeLength(), oofem::FEI3dHexaConst::edgeComputeLength(), oofem::FEI3dHexaLin::edgeComputeLength(), oofem::FEI3dTetLin::edgeComputeLength(), oofem::FEI2dTrQuad::edgeEvaldNds(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), enumerate(), oofem::ScalarFunction::eval(), oofem::CalculatorFunction::evaluate(), oofem::EIPrimaryUnknownMapper::evaluateAt(), oofem::InternalVariableField::evaluateAt(), oofem::Subdivision::exchangeSharedEdges(), oofem::VTKBaseExportModule::exportCellVars(), oofem::VTKBaseExportModule::exportExternalForces(), oofem::POIExportModule::exportIntVarAs(), oofem::VTKExportModule::exportIntVarAs(), oofem::VTKBaseExportModule::exportIntVars(), oofem::VTKXMLLatticeExportModule::exportIntVars(), oofem::VTKXMLPeriodicExportModule::exportIntVars(), oofem::VTKXMLXFemExportModule::exportIntVars2(), oofem::VTKXMLExportModule::exportIntVarsInGpAs(), oofem::VTKBaseExportModule::exportPrimaryVars(), oofem::VTKXMLLatticeExportModule::exportPrimaryVars(), oofem::VTKXMLPeriodicExportModule::exportPrimaryVars(), oofem::VTKExportModule::exportPrimVarAs(), oofem::VTKBaseExportModule::exportSetMembership(), oofem::NonlocalMaterialWTP::fastRebuildNonlocalTables(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::Delamination::findInitiationFronts(), findNonzeros(), oofem::SloanLevelStructure::formYourself(), oofem::Subdivision::RS_Tetra::generate(), oofem::Subdivision::RS_Triangle::generate(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::MPlasticMaterial2::getNewPopulation(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::MPlasticMaterial2::getPopulationSignature(), oofem::ReactionErrorCheckingRule::getValue(), oofem::M1Material::give3dMaterialStiffnessMatrix(), oofem::SpatialLocalizer::giveAllElementsWithNodesWithinBox(), oofem::RefinedElement::giveBcDofArray1D(), oofem::RefinedElement::giveBcDofArray2D(), oofem::RefinedElement::giveBcDofArray3D(), oofem::Q1Element::giveBoundaryEdgeNodes(), oofem::RefinedElement::giveBoundaryFlagArray(), oofem::RefinedElement::giveBoundaryLoadArray1D(), oofem::RefinedElement::giveBoundaryLoadArray2D(), oofem::RefinedElement::giveBoundaryLoadArray3D(), oofem::Element::giveBoundaryLocationArray(), oofem::Element::giveBoundaryLocationArray(), oofem::Tr2Shell7::giveBoundaryLocationArray(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::OctantRecT< T > *::giveChildContainingPoint(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::FETIBoundaryDofManager::giveCompleteLocationArray(), oofem::Beam3d::giveCompositeExportData(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::RCM2Material::giveCrackedStiffnessMatrix(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::VTKXMLXFemExportModule::giveDataHeaders(), oofem::MITC4Shell::giveDirectorVectors(), oofem::ActiveDof::giveDofIDs(), oofem::CombinedZZSIRemeshingCriteria::giveDofManDensity(), oofem::HuertaRemeshingCriteria::giveDofManDensity(), oofem::ZZRemeshingCriteria::giveDofManDensity(), oofem::SADGBLine1::giveDofManDofIDMask(), oofem::CCTPlate::giveEdgeDofMapping(), oofem::DKTPlate3d::giveEdgeDofMapping(), oofem::DKTPlate::giveEdgeDofMapping(), oofem::LIBeam2d::giveEdgeDofMapping(), oofem::LIBeam2dNL::giveEdgeDofMapping(), oofem::LIBeam3d2::giveEdgeDofMapping(), oofem::LIBeam3d::giveEdgeDofMapping(), oofem::LIBeam3dNL2::giveEdgeDofMapping(), oofem::LIBeam3dNL::giveEdgeDofMapping(), oofem::PFEMElement2d::giveEdgeDofMapping(), oofem::Structural2DElement::giveEdgeDofMapping(), oofem::Structural3DElement::giveEdgeDofMapping(), oofem::Tr_Warp::giveEdgeDofMapping(), oofem::TrPlanestressRotAllman::giveEdgeDofMapping(), oofem::Truss2d::giveEdgeDofMapping(), oofem::Truss3d::giveEdgeDofMapping(), oofem::EnrichmentItem::giveEIDofIdArray(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::VTKBaseExportModule::giveElementCell(), oofem::VTKExportModule::giveElementCell(), oofem::DummySpatialLocalizer::giveElementClosestToPoint(), oofem::NonlocalMaterialWTP::giveElementNonlocalDepArry(), oofem::ConnectivityTable::giveElementsWithNodes(), oofem::ActiveDof::giveEquationNumbers(), oofem::Dof::giveEquationNumbers(), oofem::ContactBoundaryCondition::giveExportData(), oofem::OOFEMTXTInputRecord::giveField(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::DofManager::giveInputRecord(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::LayeredCrossSection::giveInterfaceMaterial(), oofem::LayeredCrossSection::giveInterfaceMaterialNum(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::StructuralMaterial::giveInvertedVoigtVectorMask(), oofem::RCM2Material::giveIPValue(), oofem::BSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::LayeredCrossSection::giveLayerMaterial(), oofem::DirectErrorIndicatorRC::giveLocalDofManDensity(), oofem::DirectErrorIndicatorRC::giveLocalDofManIndicator(), oofem::LinearConstraintBC::giveLocArray(), oofem::Lattice2dBoundary::giveLocation(), oofem::DofManager::giveLocationArray(), oofem::BaseMixedPressureElement::giveLocationArrayOfDofIDs(), oofem::GradientDamageElement::giveLocationArrayOfDofIDs(), oofem::LinearConstraintBC::giveLocationArrays(), oofem::MixedGradientPressureNeumann::giveLocationArrays(), oofem::MixedGradientPressureWeakPeriodic::giveLocationArrays(), oofem::PrescribedDispSlipBCNeumannRC::giveLocationArrays(), oofem::PrescribedGradientBCNeumann::giveLocationArrays(), oofem::SurfaceTensionBoundaryCondition::giveLocationArrays(), oofem::TransverseReinfConstraint::giveLocationArrays(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::ActiveDof::giveMasterDofManArray(), oofem::Dof::giveMasterDofManArray(), oofem::SimpleSlaveDof::giveMasterDofManArray(), oofem::DofManager::giveMasterDofMans(), oofem::LEPlic::giveNodalScalarRepresentation(), oofem::Subdivision::RS_Element::giveNode(), oofem::Set::giveNodeList(), oofem::ConnectivityTable::giveNodeNeighbourList(), oofem::CemhydMatStatus::GivePower(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::CompoDamageMat::giveRealStressVector(), oofem::M1Material::giveRealStressVector_3d(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::Subdivision::RS_SharedEdge::giveSharedPartitions(), oofem::Shell7Base::giveShellExportData(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::Subdivision::RS_Tetra::giveSideNodes(), oofem::Subdivision::RS_Triangle::giveSideNodes(), oofem::J2Mat::giveStressBackVector(), oofem::Skyline::giveSubMatrix(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::CCTPlate3d::giveSurfaceDofMapping(), oofem::DKTPlate3d::giveSurfaceDofMapping(), oofem::DKTPlate::giveSurfaceDofMapping(), oofem::QDKTPlate::giveSurfaceDofMapping(), oofem::Structural3DElement::giveSurfaceDofMapping(), oofem::Tr2Shell7::giveSurfaceDofMapping(), oofem::Tr2Shell7XFEM::giveSurfaceDofMapping(), oofem::TR_SHELL11::giveSurfaceDofMapping(), oofem::TrPlaneStrRot3d::giveSurfaceDofMapping(), oofem::FCMMaterial::giveTotalLocalCrackedStiffnessMatrix(), oofem::DofGrouping::giveTotalLocationArray(), oofem::LatticeDirichletCouplingNode::giveUnknownVector(), oofem::DofManager::giveUnknownVectorOfType(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::StructuralMaterial::giveVoigtVectorMask(), oofem::LatticeBeam3dBoundary::giveVTKCoordinates(), oofem::ParmetisLoadBalancer::handleMasterSlaveDofManLinks(), oofem::DynCompRow::ILUPYourself(), oofem::Subdivision::RS_Node::importConnectivity(), oofem::Subdivision::RS_Tetra::importConnectivity(), oofem::Subdivision::RS_Triangle::importConnectivity(), oofem::DummySpatialLocalizer::init(), oofem::Natural2GlobalOrdering::init(), oofem::QuasicontinuumNumberingscheme::init2(), oofem::BCTracker::initialize(), oofem::CompCol_ILUPreconditioner::initialize(), oofem::SlaveDof::initialize(), oofem::SloanGraph::initialize(), oofem::QuadraticInterpolation::initializeCell(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::DofManager::initializeFinish(), oofem::GeneralSlaveNode::initializeFinish(), oofem::IGAElement::initializeFinish(), oofem::IGATSplineElement::initializeFinish(), oofem::BSplineInterpolation::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::StationaryTransportProblem::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::ListBasedEI::initiateFronts(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::NRSolver::initPrescribedEqs(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::VTKBaseExportModule::initRegionNodeNumbering(), oofem::VTKExportModule::initRegionNodeNumbering(), oofem::VTKXMLLatticeExportModule::initRegionNodeNumbering(), oofem::VTKXMLPeriodicExportModule::initRegionNodeNumbering(), oofem::OctreeSpatialLocalizer::insertElementIntoOctree(), oofem::ConnectivityTable::instanciateConnectivityTable(), oofem::Delamination::instanciateYourself(), oofem::FreeConstantSurfaceLoad::isImposed(), oofem::Subdivision::isNodeLocalIrregular(), oofem::Subdivision::isNodeLocalSharedIrregular(), oofem::ParmetisLoadBalancer::labelDofManagers(), oofem::Skyline::ldl_feti_sky(), 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::DofManager::mergePartitionList(), oofem::TriangleMesherInterface::meshPSLG(), oofem::NonlocalMaterialWTP::migrate(), oofem::LoadBalancer::migrateLoad(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::MDM::MMI_map(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_showSparseMtrxStructure(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputReactionForces(), oofem::FETISolver::packDirectionVector(), oofem::Subdivision::packIrregularSharedGlobnums(), oofem::FETISolver::packPPVector(), oofem::FETISolver::packRBM(), oofem::Subdivision::packRemoteElements(), oofem::FETISolver::packResiduals(), oofem::NodalAveragingRecoveryModel::packSharedDofManData(), oofem::SPRNodalRecoveryModel::packSharedDofManData(), oofem::ZZNodalRecoveryModel::packSharedDofManData(), oofem::Subdivision::packSharedEdges(), oofem::Subdivision::packSharedIrregulars(), oofem::FETISolver::packSolution(), oofem::Beam2d::postInitialize(), oofem::Beam3d::postInitialize(), oofem::EngngModel::printOutputAt(), oofem::TransientTransportProblem::printOutputAt(), oofem::StructuralEngngModel::printReactionForces(), printYourself(), printYourself(), oofem::ListBasedEI::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::PLnodeRadius::propagateInterface(), oofem::ProblemCommunicator::quickSortPartition(), oofem::quickSortPartition(), oofem::Skyline::rbmodes(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::Lattice3dBoundary::recalculateCoordinates(), oofem::Lattice3dBoundaryTruss::recalculateCoordinates(), oofem::LatticeLink3dBoundary::recalculateCoordinates(), oofem::LIBeam3dBoundary::recalculateCoordinates(), oofem::LTRSpaceBoundary::recalculateCoordinates(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), oofem::LevelSetPCS::redistance(), oofem::RefinedMesh::refineMeshGlobally(), oofem::REGISTER_Element(), oofem::REGISTER_Element(), oofem::REGISTER_Element(), oofem::REGISTER_EnrichmentFront(), oofem::REGISTER_EnrichmentFront(), oofem::Element::restoreContext(), oofem::Element::saveContext(), oofem::QClinearStatic::setActivatedElementList(), oofem::QClinearStatic::setActivatedNodeList(), oofem::UniformGridField::setGeometry(), oofem::SkylineUnsym::setInternalStructure(), oofem::Subdivision::RS_Element::setIrregular(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::Subdivision::RS_Element::setNeighbor(), oofem::ExportRegion::setNumberOfInternalVarsToExport(), oofem::ExportRegion::setNumberOfPrimaryVarsToExport(), oofem::Subdivision::RS_Element::setSharedEdge(), oofem::Element::setSharedEdgeID(), oofem::Element::setSharedSurfaceID(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::FETICommunicator::setUpCommunicationMaps(), oofem::FETISolver::setUpCommunicationMaps(), oofem::NodeCommunicator::setUpCommunicationMaps(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::QuasicontinuumVTKXMLExportModule::setupVTKPiece(), oofem::VTKBaseExportModule::setupVTKPiece(), oofem::VTKXMLLatticeExportModule::setupVTKPiece(), oofem::VTKXMLPeriodicExportModule::setupVTKPiece(), oofem::VTKXMLLatticeExportModule::setupVTKPieceCross(), oofem::StructuralElement::showSparseMtrxStructure(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::Subdivision::smoothMesh(), oofem::FreemInterface::smoothNodalDensities(), oofem::InverseIteration::solve(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::DEIDynamic::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::CCTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::DKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Q27Space::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QQuad1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR_SHELL11::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::CCTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::DKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Q27Space::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QQuad1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR_SHELL11::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Tria2PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::OctantRec::testBoundingBox(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::TR1_2D_PFEM::TR1_2D_PFEM(), oofem::QClinearStatic::transformMeshToParticles(), oofem::Quasicontinuum::transformStiffnessTensorToMatrix(), oofem::FETISolver::unpackDirectionVector(), oofem::Subdivision::unpackIrregularSharedGlobnums(), oofem::NonlocalMaterialWTP::unpackRemoteElements(), oofem::Subdivision::unpackRemoteElements(), oofem::NodalAveragingRecoveryModel::unpackSharedDofManData(), oofem::SPRNodalRecoveryModel::unpackSharedDofManData(), oofem::ZZNodalRecoveryModel::unpackSharedDofManData(), oofem::Subdivision::unpackSharedEdges(), oofem::Subdivision::unpackSharedIrregulars(), oofem::FETISolver::unpackSolution(), oofem::Subdivision::RS_Tetra::update_neighbours(), oofem::Subdivision::RS_Triangle::update_neighbours(), oofem::RCM2Material::updateActiveCrackMap(), oofem::FreeWarping::updateComputedResults(), oofem::RCM2Material::updateCrackStatus(), oofem::XfemManager::updateNodeEnrichmentItemMap(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::LevelSetPCS::updatePosition(), oofem::NodalRecoveryModel::updateRegionRecoveredValues(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::FreeWarping::updateStiffnessMatrix(), oofem::VTKXMLLatticeExportModule::writeVTKPieceCross(), oofem::VTKXMLExportModule::writeVTKPieceProlog(), oofem::VTKXMLXFemExportModule::writeXFEMVars(), and oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix().
|
inline |
Coefficient access function. Returns value of coefficient at given position of the receiver.
| i | position of coefficient in array. |
Definition at line 117 of file intarray.h.
References checkBounds(), and values.
|
inline |
Definition at line 71 of file intarray.h.
Referenced by oofem::VTKXMLPeriodicExportModule::exportPrimaryVars(), oofem::InverseIteration::solve(), and sort().
|
inline |
Definition at line 73 of file intarray.h.
|
inline |
Checks size of receiver towards requested bounds. Current implementation will call exit(1) if dimension mismatch found.
| i | Required size of receiver |
Definition at line 159 of file intarray.h.
References giveSize(), OOFEM_ERROR, and values.
Referenced by at(), at(), erase(), operator[](), and operator[]().
|
inline |
Clears the array (zero size).
Definition at line 185 of file intarray.h.
Referenced by oofem::MMALeastSquareProjection::__init(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::PhaseFieldElement::computeLocationArrayOfDofIDs(), oofem::Shell7BaseXFEM::computeOrderingArray(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::PoissonElement::getEdgeLocalCodeNumbers(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::PoissonElement::getSurfaceLocalCodeNumbers(), oofem::SpatialLocalizer::giveAllElementsWithNodesWithinBox(), oofem::Element::giveBoundaryLocationArray(), oofem::Element::giveBoundaryLocationArray(), oofem::ActiveDof::giveDofIDs(), oofem::SlaveDof::giveDofIDs(), oofem::Element::giveDofManDofIDMask(), oofem::HTSelement::giveDofManDofIDMask(), oofem::StructuralElement::giveEdgeDofMapping(), oofem::NonlocalMaterialWTP::giveElementNonlocalDepArry(), oofem::ActiveDof::giveEquationNumbers(), oofem::SlaveDof::giveEquationNumbers(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::Element::giveInternalDofManDofIDMask(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::DofManager::giveLocationArray(), oofem::Element::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::PrescribedGradientBCWeak::giveTractionLocationArray(), oofem::StructuralMaterial::giveVoigtSymVectorMask(), oofem::TSplineInterpolation::initializeFrom(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::ParmetisLoadBalancer::labelDofManagers(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::PLCZdamageRadius::propagateInterface(), oofem::PLnodeRadius::propagateInterface(), oofem::Shell7BaseXFEM::recoverShearStress(), and oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs().
|
inline |
Definition at line 292 of file intarray.h.
References findFirstIndexOf().
Referenced by oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::PrescribedDispSlipBCDirichletRC::give(), oofem::ConnectivityTable::giveElementsWithNodes(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::FCMMaterialStatus::giveMaxNumberOfCracks(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Subdivision::RS_SharedEdge::giveSharedPartitions(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::DofManager::initializeFinish(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::Subdivision::RS_Triangle::numberSharedEdges(), oofem::Subdivision::packIrregularSharedGlobnums(), oofem::NonlocalMaterialWTP::packRemoteElements(), oofem::Subdivision::packRemoteElements(), oofem::Subdivision::packSharedEdges(), oofem::Subdivision::packSharedIrregulars(), oofem::MicroMaterial::setMacroProperties(), oofem::PrescribedDispSlipBCDirichletRC::updateCoefficientMatrix(), and oofem::RCM2Material::updateCrackStatus().
| bool oofem::IntArray::containsOnlyZeroes | ( | ) | const |
Checks if receiver is all zero.
Definition at line 121 of file intarray.C.
References values.
Referenced by oofem::EnrichmentItem::createEnrichedDofs().
|
inline |
Checks if sorted receiver contains a given value.
Definition at line 247 of file intarray.h.
References findSorted().
Referenced by oofem::TransportGradientDirichlet::computeXi().
|
inline |
Definition at line 72 of file intarray.h.
Referenced by oofem::VTKXMLPeriodicExportModule::exportPrimaryVars(), oofem::InverseIteration::solve(), and sort().
|
inline |
Definition at line 74 of file intarray.h.
| void oofem::IntArray::enumerate | ( | int | maxVal | ) |
Resizes receiver and enumerates from 1 to the maximum value given.
| maxVal | to enumerate to. |
Definition at line 85 of file intarray.C.
Referenced by oofem::FEInterpolation2d::boundarySurfaceGiveNodes(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::Quad10_2D_SUPG::giveLocalVelocityDofMap(), oofem::Element::giveRotationMatrix(), oofem::MITC4Shell::giveSurfaceDofMapping(), oofem::StructuralMaterial::giveVoigtSymVectorMask(), oofem::InverseIteration::solve(), and oofem::PetscSparseMtrx::toFloatMatrix().
| 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)
| pos | Position to erase. |
Definition at line 112 of file intarray.C.
References checkBounds(), and values.
Referenced by oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::ConnectivityTable::giveElementsWithNodes(), and oofem::SolutionbasedShapeFunction::initializeSurfaceData().
| 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.
| value | Value to erase. |
Definition at line 323 of file intarray.C.
References values.
| 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.
| iarray | Array to search for values common with receiver. |
| common | Array of common values. |
| allocChunk | If reallocation needed, an additional space for allocChunk values will be allocated. |
Definition at line 332 of file intarray.C.
References followedBy(), giveSize(), IntArray(), 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.
| value | Scanned value. |
Definition at line 280 of file intarray.C.
References values.
Referenced by oofem::PrimaryField::__evaluateAt(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::DGProblem::constructBoundaryEntities(), contains(), oofem::LoadBalancer::deleteRemoteDofManagers(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::DummySpatialLocalizer::giveElementContainingPoint(), oofem::OctreeSpatialLocalizer::giveElementContainingPoint(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), insertOnce(), oofem::TriangleMesherInterface::meshPSLG(), oofem::LoadBalancer::packMigratingData(), oofem::ParmetisLoadBalancer::packSharedDmanPartitions(), oofem::Subdivision::RS_Tetra::RS_Tetra(), oofem::Subdivision::RS_Triangle::RS_Triangle(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::Subdivision::smoothMesh(), and oofem::Subdivision::RS_Tetra::update_neighbours().
| void oofem::IntArray::findNonzeros | ( | const IntArray & | logical | ) |
Finds all indices where the input array is nonzero
| logical | Array of logical values (0 = false, nonzero = true) to have index extracted. |
Definition at line 155 of file intarray.C.
References at(), giveSize(), IntArray(), and values.
Referenced by oofem::Set::computeIntArray(), oofem::EnrichmentItem::createEnrichedDofs(), and oofem::DofGrouping::giveTotalLocationArray().
| int oofem::IntArray::findSorted | ( | int | value | ) | const |
Finds the first occurrence of given value, assuming that the receiver is sorted.
Definition at line 293 of file intarray.C.
References values.
Referenced by oofem::ConnectivityTable::buildSharedBoundaryEntities(), oofem::DGProblem::constructBoundaryEntities(), containsSorted(), oofem::OctreeSpatialLocalizer::giveElementsWithIPWithinBox(), and oofem::XfemManager::initiateFronts().
| void oofem::IntArray::followedBy | ( | const IntArray & | b, |
| int | allocChunk = 0 ) |
Appends array b at the end of receiver.
| b | Array to be appended at the end of receiver |
| allocChunk | If reallocation needed, an additional space for allocChunk values will be allocated to prevent excessive reallocation. |
Definition at line 94 of file intarray.C.
References giveSize(), IntArray(), and values.
Referenced by oofem::MMALeastSquareProjection::__init(), oofem::TransverseReinfConstraint::assemble(), oofem::PrescribedGradientBCWeak::assembleExtraDisplock(), oofem::TransverseReinfConstraint::assembleVector(), oofem::Shell7BaseXFEM::computeDiscSolutionVector(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::CoupledFieldsElement::computeLocationArrayOfDofIDs(), oofem::PhaseFieldElement::computeLocationArrayOfDofIDs(), oofem::StructuralInterfaceElementPhF::computeLocationArrayOfDofIDs(), oofem::TransportGradientDirichlet::computeXi(), oofem::DGProblem::constructBoundaryEntities(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::MatlabExportModule::doOutputReactionForces(), findCommonValuesSorted(), oofem::SloanLevelStructure::formYourself(), oofem::MPElement::getEdgeElementCodeNumbers(), oofem::Integral::getElementTermCodeNumbers(), oofem::MPElement::getLocalCodeNumbers(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::MPElement::getSurfaceElementCodeNumbers(), oofem::Element::giveBoundaryLocationArray(), oofem::Element::giveBoundaryLocationArray(), oofem::DofManager::giveCompleteLocationArray(), oofem::DofManager::giveCompleteMasterDofIDArray(), oofem::ActiveDof::giveDofIDs(), oofem::SlaveDof::giveDofIDs(), oofem::PlaneStress2dXfem::giveDofManDofIDMask(), oofem::QTrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::Shell7BaseXFEM::giveDofManDofIDMask(), oofem::TrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::XfemManager::giveEnrichedDofIDs(), oofem::ActiveDof::giveEquationNumbers(), oofem::SlaveDof::giveEquationNumbers(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::DofManager::giveInputRecord(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::TSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::TSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::ContactPair::giveLocationArray(), oofem::DofManager::giveLocationArray(), oofem::Element::giveLocationArray(), oofem::Element::giveLocationArray(), oofem::PrescribedDispSlipBCNeumannRC::giveLocationArrays(), oofem::TransverseReinfConstraint::giveLocationArrays(), oofem::DofManager::giveMasterDofIDArray(), oofem::ActiveDof::giveMasterDofManArray(), oofem::SlaveDof::giveMasterDofManArray(), oofem::StructuralElement::giveNonlocalLocationArray(), oofem::EnrichmentItem::givePotentialEIDofIdArray(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::DofGrouping::giveTotalLocationArray(), oofem::PrescribedGradientBCWeak::giveTractionLocationArray(), oofem::XfemManager::initiateFronts(), insertOnce(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::MDM::MMI_map(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::Subdivision::RS_Triangle::numberSharedEdges(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::Delamination::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::VTKBaseExportModule::setupVTKPiece(), oofem::Set::updateLocalElementNumbering(), and oofem::Set::updateLocalNodeNumbering().
| void oofem::IntArray::followedBy | ( | int | b, |
| int | allocChunk = 0 ) |
Appends given Number at the end of receiver.
| b | value to be appended. |
| allocChunk | If reallocation needed, an additional space for allocChunk values will be allocated to prevent excessive reallocation. |
Definition at line 103 of file intarray.C.
References values.
| int oofem::IntArray::givePackSize | ( | DataStream & | buff | ) | const |
Returns how much space is needed to pack receivers message.
| buff | Buffer used for packing. |
Definition at line 274 of file intarray.C.
References oofem::DataStream::givePackSizeOfInt(), oofem::DataStream::givePackSizeOfSizet(), and giveSize().
Referenced by oofem::ElementCommunicator::setUpCommunicationMaps().
|
inline |
Definition at line 346 of file intarray.h.
References values.
|
inline |
Breaks encapsulation. Avoid using this unless absolutely necessary.
Definition at line 345 of file intarray.h.
References values.
Referenced by oofem::PetscSparseMtrx::assemble(), oofem::PetscSparseMtrx::assemble(), oofem::FloatMatrix::beInverseOf(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::FloatMatrix::computeReciprocalCondition(), oofem::PetscSparseMtrx::giveSubMatrix(), oofem::ParmetisLoadBalancer::initGlobalParmetisElementNumbering(), oofem::TriangleMesherInterface::meshPSLG(), oofem::MKLPardisoSolver::solve(), oofem::PardisoProjectOrgSolver::solve(), oofem::SuperLUSolver::solve(), oofem::FloatMatrix::solveForRhs(), oofem::FloatMatrix::solveForRhs(), and oofem::PetscSparseMtrx::toFloatMatrix().
|
inline |
Definition at line 211 of file intarray.h.
References values.
Referenced by oofem::PrimaryField::__evaluateAt(), oofem::MMALeastSquareProjection::__init(), oofem::MMAShapeFunctProjection::__init(), oofem::QuadraticInterpolation::allocateDofMans(), oofem::CompCol::assemble(), oofem::DynCompCol::assemble(), oofem::DynCompCol::assemble(), oofem::DynCompRow::assemble(), oofem::DynCompRow::assemble(), oofem::FloatArray::assemble(), oofem::FloatMatrix::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::PetscSparseMtrx::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedGradientBCWeak::assemble(), oofem::PrescribedMean::assemble(), oofem::Skyline::assemble(), oofem::SkylineUnsym::assemble(), oofem::SkylineUnsym::assemble(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::SymCompCol::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::TransverseReinfConstraint::assemble(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnStress(), oofem::FloatArray::assembleSquared(), oofem::FloatMatrix::assembleT(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::TransverseReinfConstraint::assembleVector(), oofem::EngngModel::assembleVectorFromBC(), oofem::EngngModel::assembleVectorFromDofManagers(), oofem::EngngModel::assembleVectorFromElements(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorStress(), oofem::FloatMatrix::beSubMatrixOf(), oofem::Subdivision::RS_Tetra::bisect(), oofem::DynCompRow::buildInternalStructure(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::SkylineUnsym::buildInternalStructure(), oofem::ConnectivityTable::buildSharedBoundaryEntities(), oofem::Subdivision::RS_Node::buildTopLevelNodeConnectivity(), oofem::ReactionErrorCheckingRule::check(), checkBounds(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::DynCompCol::checkSizeTowards(), oofem::DynCompCol::checkSizeTowards(), oofem::DynCompRow::checkSizeTowards(), oofem::DynCompRow::checkSizeTowards(), oofem::RowColumn::checkSizeTowards(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::Element::computeBoundaryVectorOf(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::Element::computeDofTransformationMatrix(), oofem::PrescribedMean::computeDomainSize(), oofem::EnrichmentItem::computeEnrichedDofManDofIdArray(), oofem::TransportGradientNeumann::computeEta(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::Line2BoundaryElement::computeField(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::Set::computeIntArray(), oofem::PrescribedDispSlipBCNeumannRC::computeInterfaceLength(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith2DTringleElements(), oofem::Quasicontinuum::computeIntersectionsOfLinkWith3DTetrahedraElements(), oofem::Node::computeL2GTransformation(), oofem::DofManager::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::CoupledFieldsElement::computeLocationArrayOfDofIDs(), oofem::IntElLine1PF::computeLocationArrayOfDofIDs(), oofem::PhaseFieldElement::computeLocationArrayOfDofIDs(), oofem::StructuralInterfaceElementPhF::computeLocationArrayOfDofIDs(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::LineDistributedSpring::computeNumberOfDofs(), oofem::Structural2DElement::computeNumberOfDofs(), oofem::Structural3DElement::computeNumberOfDofs(), oofem::Shell7BaseXFEM::computeOrderingArray(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::ElementSide::computeTransformation(), oofem::Load::computeValues(), oofem::Element::computeVectorOf(), oofem::CoupledFieldsElement::computeVectorOfDofIDs(), oofem::Element::computeVectorOfPrescribed(), oofem::PrescribedDispSlipBCNeumannRC::computeWeightMatrix(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralElement::condense(), oofem::DGProblem::constructBoundaryEntities(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::SolutionbasedShapeFunction::copyDofManagersToSurfaceData(), oofem::Domain::createDofs(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::Subdivision::createMesh(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::SPRNodalRecoveryModel::determinePatchType(), oofem::SPRNodalRecoveryModel::determineValuesFromPatch(), oofem::LEPlic::doInterfaceRemapping(), oofem::MixedGradientPressureBC::domainSize(), oofem::PrescribedDispSlipHomogenization::domainSize(), oofem::PrescribedGenStrainShell7::domainSize(), oofem::PrescribedGradientHomogenization::domainSize(), oofem::TransportGradientDirichlet::domainSize(), oofem::TransportGradientNeumann::domainSize(), oofem::TransportGradientPeriodic::domainSize(), oofem::VTKXMLExportModule::doOutput(), oofem::VTKXMLXFemExportModule::doOutput(), oofem::VTKXMLLatticeExportModule::doOutputNormal(), oofem::StructuralElementEvaluator::drawIGAPatchDeformedGeometry, oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::ScalarFunction::eval(), oofem::TSplineInterpolation::evaldNdx(), oofem::TSplineInterpolation::evalN(), oofem::CalculatorFunction::evaluate(), oofem::EIPrimaryUnknownMapper::evaluateAt(), oofem::UniformGridField::evaluateAt(), oofem::Subdivision::exchangeSharedEdges(), oofem::VTKBaseExportModule::exportCellVars(), oofem::VTKBaseExportModule::exportExternalForces(), oofem::VTKBaseExportModule::exportIntVars(), oofem::VTKXMLLatticeExportModule::exportIntVars(), oofem::VTKXMLPeriodicExportModule::exportIntVars(), oofem::VTKXMLXFemExportModule::exportIntVars2(), oofem::VTKXMLExportModule::exportIntVarsInGpAs(), oofem::VTKBaseExportModule::exportPrimaryVars(), oofem::VTKXMLLatticeExportModule::exportPrimaryVars(), oofem::VTKXMLPeriodicExportModule::exportPrimaryVars(), oofem::VTKBaseExportModule::exportSetMembership(), findCommonValuesSorted(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::Delamination::findInitiationFronts(), findNonzeros(), followedBy(), oofem::ExportRegion::getCellConnectivity(), oofem::PythonExpression::getDict(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::MPlasticMaterial2::getNewPopulation(), oofem::VTKBaseExportModule::getNodalVariableFromIS(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::MPlasticMaterial2::getPopulationSignature(), oofem::ReactionErrorCheckingRule::getValue(), oofem::M1Material::give3dMaterialStiffnessMatrix(), oofem::SpatialLocalizer::giveAllElementsWithNodesWithinBox(), oofem::Q1Element::giveBoundaryEdgeNodes(), oofem::Element::giveBoundaryLocationArray(), oofem::Element::giveBoundaryLocationArray(), oofem::Tr2Shell7::giveBoundaryLocationArray(), oofem::Beam3d::giveCompositeExportData(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::VTKXMLXFemExportModule::giveDataHeaders(), oofem::MITC4Shell::giveDirectorVectors(), oofem::CombinedZZSIRemeshingCriteria::giveDofManDensity(), oofem::HuertaRemeshingCriteria::giveDofManDensity(), oofem::ZZRemeshingCriteria::giveDofManDensity(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::EnrichmentItem::giveEIDofIdArray(), oofem::VTKBaseExportModule::giveElementCell(), oofem::DummySpatialLocalizer::giveElementClosestToPoint(), oofem::ConnectivityTable::giveElementsWithNodes(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::StructuralMaterial::giveFullVectorFormF(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::StructuralMaterial::giveInvertedVoigtVectorMask(), oofem::TSplineInterpolation::giveJacobianMatrixAt(), oofem::DirectErrorIndicatorRC::giveLocalDofManDensity(), oofem::DirectErrorIndicatorRC::giveLocalDofManIndicator(), oofem::DofManager::giveLocationArray(), oofem::BaseMixedPressureElement::giveLocationArrayOfDofIDs(), oofem::GradientDamageElement::giveLocationArrayOfDofIDs(), oofem::MixedGradientPressureNeumann::giveLocationArrays(), oofem::MixedGradientPressureWeakPeriodic::giveLocationArrays(), oofem::PrescribedDispSlipBCNeumannRC::giveLocationArrays(), oofem::PrescribedGradientBCNeumann::giveLocationArrays(), oofem::SurfaceTensionBoundaryCondition::giveLocationArrays(), oofem::TransportGradientNeumann::giveLocationArrays(), oofem::TransverseReinfConstraint::giveLocationArrays(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::DofManager::giveMasterDofMans(), oofem::LEPlic::giveNodalScalarRepresentation(), oofem::ConnectivityTable::giveNodeNeighbourList(), oofem::Shell7BaseXFEM::giveNumberOfDofs(), oofem::DofManager::giveNumberOfPrimaryMasterDofs(), givePackSize(), oofem::DofManager::givePrescribedUnknownVector(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::StructuralMaterial::giveReducedSymVectorForm(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::Subdivision::RS_SharedEdge::giveSharedPartitions(), oofem::Shell7Base::giveShellExportData(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::StructuralMaterial::giveSizeOfVoigtSymVector(), oofem::StructuralMaterial::giveSizeOfVoigtVector(), oofem::J2Mat::giveStressBackVector(), oofem::PetscSparseMtrx::giveSubMatrix(), oofem::Skyline::giveSubMatrix(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::FCMMaterial::giveTotalLocalCrackedStiffnessMatrix(), oofem::DofGrouping::giveTotalLocationArray(), oofem::DofManager::giveUnknownVector(), oofem::DofManager::giveUnknownVector(), oofem::LatticeDirichletCouplingNode::giveUnknownVector(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::ParmetisLoadBalancer::handleMasterSlaveDofManLinks(), oofem::DynCompRow::ILUPYourself(), oofem::Subdivision::RS_Node::importConnectivity(), oofem::Subdivision::RS_Tetra::importConnectivity(), oofem::Subdivision::RS_Triangle::importConnectivity(), oofem::Natural2GlobalOrdering::init(), oofem::QuasicontinuumNumberingscheme::init2(), oofem::BCTracker::initialize(), oofem::SlaveDof::initialize(), oofem::DofManager::initializeFinish(), oofem::GeneralSlaveNode::initializeFinish(), oofem::ActiveBoundaryCondition::initializeFrom(), oofem::BSplineInterpolation::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::NRSolver::initializeFrom(), oofem::StationaryTransportProblem::initializeFrom(), oofem::TSplineInterpolation::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::LoadBalancer::initializeWtp(), oofem::ListBasedEI::initiateFronts(), oofem::XfemManager::initiateFronts(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::VTKBaseExportModule::initRegionNodeNumbering(), oofem::VTKXMLLatticeExportModule::initRegionNodeNumbering(), oofem::VTKXMLPeriodicExportModule::initRegionNodeNumbering(), oofem::Delamination::instanciateYourself(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentBStressSteel(), oofem::TransverseReinfConstraint::integrateTangentOnConcrete(), oofem::TransverseReinfConstraint::integrateTangentOnSteel(), oofem::FreeConstantSurfaceLoad::isImposed(), 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::DofManager::mergePartitionList(), oofem::TriangleMesherInterface::meshPSLG(), oofem::NonlocalMaterialWTP::migrate(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_showSparseMtrxStructure(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), operator<<, oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputReactionForces(), oofem::FETISolver::packPPVector(), oofem::FETISolver::packRBM(), oofem::FETISolver::packResiduals(), oofem::Beam2d::postInitialize(), oofem::Beam3d::postInitialize(), oofem::EngngModel::printOutputAt(), oofem::TransientTransportProblem::printOutputAt(), oofem::StructuralEngngModel::printReactionForces(), printYourself(), printYourself(), printYourselfToFile(), oofem::ListBasedEI::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::PLnodeRadius::propagateInterface(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::REGISTER_EnrichmentFront(), oofem::REGISTER_EnrichmentFront(), oofem::QClinearStatic::setActivatedElementList(), oofem::QClinearStatic::setActivatedNodeList(), oofem::Element::setDofManagers(), oofem::UniformGridField::setGeometry(), oofem::SkylineUnsym::setInternalStructure(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::MicroMaterial::setMacroProperties(), oofem::ExportRegion::setNumberOfInternalVarsToExport(), oofem::ExportRegion::setNumberOfPrimaryVarsToExport(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::FETICommunicator::setUpCommunicationMaps(), oofem::FETISolver::setUpCommunicationMaps(), oofem::NodeCommunicator::setUpCommunicationMaps(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::QuasicontinuumVTKXMLExportModule::setupVTKPiece(), oofem::VTKBaseExportModule::setupVTKPiece(), oofem::VTKXMLLatticeExportModule::setupVTKPiece(), oofem::VTKXMLPeriodicExportModule::setupVTKPiece(), oofem::VTKXMLLatticeExportModule::setupVTKPieceCross(), oofem::StructuralElement::showSparseMtrxStructure(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::FreemInterface::smoothNodalDensities(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::DEIDynamic::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::sort(), oofem::ProblemCommunicator::sortCommMap(), oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::PetscSparseMtrx::toFloatMatrix(), oofem::FETISolver::unpackDirectionVector(), oofem::Subdivision::unpackIrregularSharedGlobnums(), oofem::Subdivision::unpackSharedEdges(), oofem::Subdivision::unpackSharedIrregulars(), oofem::FETISolver::unpackSolution(), oofem::Subdivision::RS_Tetra::update_neighbours(), oofem::Subdivision::RS_Triangle::update_neighbours(), oofem::XfemManager::updateNodeEnrichmentItemMap(), oofem::LevelSetPCS::updatePosition(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::VTKXMLLatticeExportModule::writeVTKPieceCross(), and oofem::VTKXMLExportModule::writeVTKPieceProlog().
| 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.
| p | Value to insert. |
Definition at line 361 of file intarray.C.
References findFirstIndexOf(), and followedBy().
Referenced by oofem::SolutionbasedShapeFunction::initializeSurfaceData().
| 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.
| value | value to insert. |
| allocChunk | If reallocation needed, an additional space for allocChunk values will be allocated. |
Definition at line 299 of file intarray.C.
References values.
Referenced by oofem::SolutionbasedShapeFunction::splitBoundaryNodeIDs(), and oofem::ListBasedEI::updateNodeEnrMarker().
| bool oofem::IntArray::insertSortedOnce | ( | int | value, |
| int | allocChunk = 0 ) |
Inserts given value into a receiver, which is assumed to be sorted. The value is inserted only if it does not exist. The size of receiver is changed accordingly.
| value | Value to insert. |
| allocChunk | If reallocation needed, an additional space for allocChunk values will be allocated. |
Definition at line 309 of file intarray.C.
References values.
Referenced by oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::TransportGradientDirichlet::computeXi(), oofem::DummySpatialLocalizer::giveAllElementsWithIpWithinBox(), oofem::SpatialLocalizer::giveAllElementsWithNodesWithinBox(), oofem::ConnectivityTable::giveElementNeighbourList(), oofem::OctreeSpatialLocalizer::giveElementsWithIPWithinBox(), oofem::DofManager::giveMasterDofMans(), oofem::ConnectivityTable::giveNodeNeighbourList(), oofem::XfemManager::initiateFronts(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::PLCZdamageRadius::propagateInterface(), and oofem::PLnodeRadius::propagateInterface().
| bool oofem::IntArray::isAllFinite | ( | ) | const |
Returns true if no element is NAN or infinite.
Definition at line 207 of file intarray.C.
References values.
|
inline |
Checks if receiver is empty (i.e., zero sized).
Definition at line 217 of file intarray.h.
References values.
Referenced by oofem::EngngModel::assembleVectorFromElements(), oofem::StructuralElement::computeConsistentMassMatrix(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::Node::computeL2GTransformation(), oofem::DofManager::computeM2LTransformation(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::EIPrimaryUnknownMapper::evaluateAt(), oofem::SloanLevelStructure::formYourself(), oofem::OctreeSpatialLocalizer::giveAllElementsWithIpWithinBox(), oofem::SlaveDof::initialize(), maximum(), minimum(), oofem::Element::setSharedEdgeID(), oofem::Element::setSharedSurfaceID(), and oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix().
| int oofem::IntArray::maximum | ( | ) | const |
Finds the maximum component in the array.
Definition at line 144 of file intarray.C.
References isEmpty(), OOFEM_ERROR, and values.
Referenced by oofem::FloatArray::beSubArrayOf(), oofem::FloatMatrix::beSubMatrixOf(), oofem::FloatArray::checkSizeTowards(), oofem::Set::computeIntArray(), and oofem::RCM2Material::giveRealPrincipalStressVector3d().
| int oofem::IntArray::minimum | ( | ) | const |
Finds the minimum component in the array.
Definition at line 133 of file intarray.C.
References isEmpty(), OOFEM_ERROR, and values.
Referenced by oofem::FloatArray::beSubArrayOf(), oofem::FloatMatrix::beSubMatrixOf(), and oofem::ParallelOrdering::isLocal().
|
inline |
Definition at line 365 of file intarray.h.
References values.
|
inline |
Coefficient access function. Returns value of coefficient at given position of the receiver. Provides 0-based indexing access.
| i | Position of coefficient in array. |
Definition at line 130 of file intarray.h.
References operator[]().
|
inline |
Coefficient access function. Returns value of coefficient at given position of the receiver. Provides 0-based indexing access.
| i | position of coefficient in array. |
Definition at line 144 of file intarray.h.
References operator[]().
|
inline |
|
inline |
Definition at line 131 of file intarray.h.
References checkBounds(), and values.
Referenced by operator()(), and operator()().
|
inline |
Definition at line 145 of file intarray.h.
References checkBounds(), and values.
| void oofem::IntArray::preallocate | ( | int | futureSize | ) |
Preallocates receiver to given futureSize if larger then allocatedSize.
| futureSize | Size to be allocated. |
Definition at line 79 of file intarray.C.
References values.
Referenced by oofem::Subdivision::RS_Tetra::bisect(), oofem::TransportGradientDirichlet::computeXi(), oofem::Subdivision::exchangeSharedEdges(), oofem::ActiveDof::giveDofIDs(), oofem::SlaveDof::giveDofIDs(), oofem::ActiveDof::giveEquationNumbers(), oofem::SlaveDof::giveEquationNumbers(), oofem::TSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::TSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::SlaveDof::giveMasterDofManArray(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::Subdivision::unpackIrregularSharedGlobnums(), oofem::Subdivision::unpackSharedEdges(), and oofem::Subdivision::unpackSharedIrregulars().
| void oofem::IntArray::printYourself | ( | ) | const |
Prints receiver on stdout.
Definition at line 174 of file intarray.C.
References at(), and giveSize().
Referenced by oofem::MPlasticMaterial2::closestPointReturn(), and pY().
| void oofem::IntArray::printYourself | ( | const std::string | name | ) | const |
Prints receiver on stdout with custom name.
| name | Display name of reciever. |
Definition at line 191 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
| filename | Name of recieving file. |
| showDimensions | Determins if dimesions should be included in output |
Definition at line 222 of file intarray.C.
References giveSize(), and OOFEM_ERROR.
| void oofem::IntArray::pY | ( | ) | const |
Abbreviation for printYourself().
Definition at line 218 of file intarray.C.
References printYourself().
| void oofem::IntArray::resize | ( | int | n | ) |
Checks size of receiver towards requested bounds. Data is always zeroed.
| n | New size of array. |
Definition at line 73 of file intarray.C.
References values.
Referenced by oofem::MMALeastSquareProjection::__init(), oofem::Delamination::appendInputRecords(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::StructuralEngngModel::buildReactionTable(), oofem::ConnectivityTable::buildSharedBoundaryEntities(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::EnrichmentItem::computeEnrichedDofManDofIdArray(), oofem::CoupledFieldsElement::computeLocationArrayOfDofIDs(), oofem::IntElLine1PF::computeLocationArrayOfDofIDs(), oofem::StructuralInterfaceElementPhF::computeLocationArrayOfDofIDs(), oofem::Shell7BaseXFEM::computeOrderingArray(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::DGProblem::constructBoundaryEntities(), oofem::CylindricalALM::convertHPCMap(), oofem::T3DInterface::createInput(), oofem::Subdivision::createMesh(), oofem::T3DInterface::createQCInterpolationMesh(), oofem::T3DInterface::createVTKExportMesh(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::HuertaErrorEstimator::estimateError(), oofem::NonlocalMaterialWTP::fastRebuildNonlocalTables(), oofem::SloanLevelStructure::formYourself(), oofem::MPElement::getEdgeElementCodeNumbers(), oofem::Integral::getElementTermCodeNumbers(), oofem::MPElement::getLocalCodeNumbers(), oofem::MPlasticMaterial2::getNewPopulation(), oofem::MPElement::getSurfaceElementCodeNumbers(), 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::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::DofManager::giveCompleteLocationArray(), oofem::FETIBoundaryDofManager::giveCompleteLocationArray(), oofem::RCM2Material::giveCrackedStiffnessMatrix(), oofem::ActiveDof::giveDofIDs(), oofem::CCTPlate::giveEdgeDofMapping(), oofem::DKTPlate3d::giveEdgeDofMapping(), oofem::DKTPlate::giveEdgeDofMapping(), oofem::LIBeam2d::giveEdgeDofMapping(), oofem::LIBeam2dNL::giveEdgeDofMapping(), oofem::LIBeam3d2::giveEdgeDofMapping(), oofem::LIBeam3d::giveEdgeDofMapping(), oofem::LIBeam3dNL2::giveEdgeDofMapping(), oofem::LIBeam3dNL::giveEdgeDofMapping(), oofem::PFEMElement2d::giveEdgeDofMapping(), oofem::Structural2DElement::giveEdgeDofMapping(), oofem::Structural3DElement::giveEdgeDofMapping(), oofem::Tr_Warp::giveEdgeDofMapping(), oofem::TrPlanestressRotAllman::giveEdgeDofMapping(), oofem::Truss2d::giveEdgeDofMapping(), oofem::Truss3d::giveEdgeDofMapping(), oofem::EnrichmentItem::giveEIDofIdArray(), oofem::VTKBaseExportModule::giveElementCell(), oofem::VTKExportModule::giveElementCell(), oofem::ConnectivityTable::giveElementNeighbourList(), oofem::NonlocalMaterialWTP::giveElementNonlocalDepArry(), oofem::ConnectivityTable::giveElementsWithNodes(), oofem::ActiveDof::giveEquationNumbers(), oofem::Dof::giveEquationNumbers(), oofem::OOFEMTXTInputRecord::giveField(), oofem::XMLInputRecord::giveField(), oofem::StructuralMaterial::giveFirstPKStressVector_StressControl(), oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers(), oofem::StructuralMaterial::giveInvertedVoigtVectorMask(), oofem::BSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::LinearConstraintBC::giveLocArray(), oofem::DofManager::giveLocationArray(), oofem::PrescribedDispSlipBCNeumannRC::giveLocationArrays(), oofem::StructuralPenaltyContactBoundaryCondition::giveLocationArrays(), oofem::ActiveDof::giveMasterDofManArray(), oofem::Dof::giveMasterDofManArray(), oofem::SimpleSlaveDof::giveMasterDofManArray(), oofem::ConnectivityTable::giveNodeNeighbourList(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::Subdivision::RS_Tetra::giveSideNodes(), oofem::Subdivision::RS_Triangle::giveSideNodes(), oofem::CCTPlate3d::giveSurfaceDofMapping(), oofem::DKTPlate3d::giveSurfaceDofMapping(), oofem::DKTPlate::giveSurfaceDofMapping(), oofem::QDKTPlate::giveSurfaceDofMapping(), oofem::Structural3DElement::giveSurfaceDofMapping(), oofem::Tr2Shell7::giveSurfaceDofMapping(), oofem::Tr2Shell7XFEM::giveSurfaceDofMapping(), oofem::TR_SHELL11::giveSurfaceDofMapping(), oofem::TrPlaneStrRot3d::giveSurfaceDofMapping(), oofem::LIBeam3dBoundary::giveSwitches(), oofem::LTRSpaceBoundary::giveSwitches(), oofem::VTKXMLLatticeExportModule::giveSwitches(), oofem::VTKXMLPeriodicExportModule::giveSwitches(), oofem::DofGrouping::giveTotalLocationArray(), oofem::StructuralMaterial::giveVoigtVectorMask(), oofem::DynCompRow::ILUPYourself(), oofem::Subdivision::RS_Tetra::importConnectivity(), oofem::Subdivision::RS_Triangle::importConnectivity(), oofem::SloanGraph::initialize(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::XfemManager::initiateFronts(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::VTKBaseExportModule::initRegionNodeNumbering(), oofem::VTKExportModule::initRegionNodeNumbering(), oofem::VTKXMLLatticeExportModule::initRegionNodeNumbering(), oofem::VTKXMLPeriodicExportModule::initRegionNodeNumbering(), oofem::Natural2GlobalOrdering::map2New(), oofem::Natural2LocalOrdering::map2New(), oofem::Natural2GlobalOrdering::map2Old(), oofem::Natural2LocalOrdering::map2Old(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::TriangleMesherInterface::meshPSLG(), oofem::MDM::MMI_map(), oofem::TransientTransportProblem::printOutputAt(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::RefinedMesh::refineMeshGlobally(), oofem::SkylineUnsym::setInternalStructure(), oofem::ExportRegion::setNumberOfCellVarsToExport(), oofem::Element::setSharedEdgeID(), oofem::Element::setSharedSurfaceID(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::FETISolver::setUpCommunicationMaps(), oofem::VTKXMLLatticeExportModule::setupVTKPiece(), oofem::VTKXMLPeriodicExportModule::setupVTKPiece(), oofem::VTKXMLLatticeExportModule::setupVTKPieceCross(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::Subdivision::smoothMesh(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::CCTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::DKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Q27Space::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QQuad1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR_SHELL11::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::CCTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::DKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Q27Space::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QQuad1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR_SHELL11::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Tria2PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QClinearStatic::transformMeshToParticles(), oofem::NonlocalMaterialWTP::unpackRemoteElements(), oofem::Set::updateLocalElementNumbering(), 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.
| n | New size of array. |
| allocChunk | If reallocation needed, an additional space for allocChunk values will be allocated to prevent excessive reallocation. |
Definition at line 64 of file intarray.C.
References values.
Referenced by oofem::TransverseReinfConstraint::assembleVector(), oofem::StructuralEngngModel::buildReactionTable(), oofem::Q1Element::giveBoundaryEdgeNodes(), oofem::DofManager::giveCompleteLocationArray(), oofem::DofManager::giveCompleteMasterDofIDArray(), oofem::tet21ghostsolid::giveRowTransformationMatrix(), oofem::DynCompRow::ILUPYourself(), oofem::VTKXMLLatticeExportModule::initRegionNodeNumbering(), oofem::VTKXMLPeriodicExportModule::initRegionNodeNumbering(), oofem::TransientTransportProblem::printOutputAt(), and oofem::SolutionbasedShapeFunction::setLoads().
| contextIOResultType oofem::IntArray::restoreYourself | ( | DataStream & | stream | ) |
Restores array from image on stream.
Definition at line 254 of file intarray.C.
References oofem::CIO_IOERR, oofem::CIO_OK, oofem::DataStream::read(), size(), and values.
Referenced by oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::Subdivision::unpackIrregularSharedGlobnums(), oofem::LoadBalancer::unpackMigratingData(), oofem::ParmetisLoadBalancer::unpackSharedDmanPartitions(), oofem::Subdivision::unpackSharedEdges(), and oofem::Subdivision::unpackSharedIrregulars().
|
inline |
Definition at line 212 of file intarray.h.
References values.
Referenced by oofem::FloatArray::assemble(), oofem::FloatMatrix::assemble(), oofem::FloatArray::assembleSquared(), oofem::FloatArray::beSubArrayOf(), and restoreYourself().
| void oofem::IntArray::sort | ( | ) |
Sorts array.
Definition at line 369 of file intarray.C.
References begin(), and end().
Referenced by oofem::ConnectivityTable::buildSharedBoundaryEntities(), oofem::DGProblem::constructBoundaryEntities(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::XfemManager::initiateFronts(), oofem::Delamination::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), and oofem::Shell7BaseXFEM::recoverShearStress().
| contextIOResultType oofem::IntArray::storeYourself | ( | DataStream & | stream | ) | const |
Stores array to output stream.
Definition at line 238 of file intarray.C.
References oofem::CIO_IOERR, oofem::CIO_OK, values, and oofem::DataStream::write().
Referenced by oofem::Subdivision::packIrregularSharedGlobnums(), oofem::Subdivision::packSharedEdges(), oofem::Subdivision::packSharedIrregulars(), oofem::Element::saveContext(), and oofem::ElementCommunicator::setUpCommunicationMaps().
| void oofem::IntArray::zero | ( | ) |
Sets all component to zero.
Definition at line 52 of file intarray.C.
References values.
Referenced by oofem::NRSolver::checkConvergence(), oofem::StaggeredSolver::checkConvergenceDofIdArray(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::Lattice3dBoundary::computeGeometryProperties(), oofem::Lattice3dBoundaryTruss::computeGeometryProperties(), oofem::LatticeBeam3dBoundary::computeGeometryProperties(), oofem::LatticeLink3dBoundary::computeGeometryProperties(), oofem::Set::computeIntArray(), oofem::Lattice3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundaryTruss::computeStiffnessMatrix(), oofem::LatticeBeam3dBoundary::computeStiffnessMatrix(), oofem::LatticeLink3dBoundary::computeStiffnessMatrix(), oofem::Lattice3dBoundary::computeStrainVector(), oofem::Lattice3dBoundaryTruss::computeStrainVector(), oofem::LatticeLink3dBoundary::computeStrainVector(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::Lattice3dBoundary::drawDeformedGeometry(), oofem::Lattice3dBoundaryTruss::drawDeformedGeometry(), oofem::LatticeBeam3dBoundary::drawDeformedGeometry(), oofem::LatticeLink3dBoundary::drawDeformedGeometry(), oofem::Lattice3dBoundary::drawRawGeometry(), oofem::Lattice3dBoundaryTruss::drawRawGeometry(), oofem::LatticeBeam3dBoundary::drawRawGeometry(), oofem::LatticeLink3dBoundary::drawRawGeometry(), oofem::HuertaErrorEstimator::estimateError(), oofem::MPlasticMaterial2::getNewPopulation(), oofem::DKTPlate3d::giveEdgeDofMapping(), oofem::Lattice3dBoundary::giveInternalForcesVector(), oofem::Lattice3dBoundaryTruss::giveInternalForcesVector(), oofem::LatticeLink3dBoundary::giveInternalForcesVector(), oofem::StructuralMaterial::giveInvertedVoigtVectorMask(), oofem::Set::giveNodeList(), oofem::CCTPlate3d::giveSurfaceDofMapping(), oofem::DKTPlate3d::giveSurfaceDofMapping(), oofem::DKTPlate::giveSurfaceDofMapping(), oofem::QDKTPlate::giveSurfaceDofMapping(), oofem::TR_SHELL11::giveSurfaceDofMapping(), oofem::TrPlaneStrRot3d::giveSurfaceDofMapping(), oofem::VTKXMLLatticeExportModule::giveSwitches(), oofem::VTKXMLPeriodicExportModule::giveSwitches(), oofem::LatticeBeam3dBoundary::giveVTKCoordinates(), oofem::DummySpatialLocalizer::init(), oofem::Natural2GlobalOrdering::init(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::VTKBaseExportModule::initRegionNodeNumbering(), oofem::VTKExportModule::initRegionNodeNumbering(), oofem::VTKXMLLatticeExportModule::initRegionNodeNumbering(), oofem::VTKXMLPeriodicExportModule::initRegionNodeNumbering(), oofem::ConnectivityTable::instanciateConnectivityTable(), oofem::Lattice3dBoundary::recalculateCoordinates(), oofem::Lattice3dBoundaryTruss::recalculateCoordinates(), oofem::LatticeLink3dBoundary::recalculateCoordinates(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::SkylineUnsym::setInternalStructure(), oofem::TriangleMesherInterface::simplifyPSLG(), oofem::Subdivision::smoothMesh(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), and oofem::HuertaErrorEstimator::solveRefinedWholeProblem().
|
friend |
Definition at line 375 of file intarray.C.
References giveSize(), and IntArray().
|
staticconstexpr |
Definition at line 77 of file intarray.h.
|
private |
Stored values.
Definition at line 66 of file intarray.h.
Referenced by add(), at(), at(), checkBounds(), containsOnlyZeroes(), enumerate(), erase(), eraseSorted(), findCommonValuesSorted(), findFirstIndexOf(), findNonzeros(), findSorted(), followedBy(), followedBy(), givePointer(), givePointer(), giveSize(), insertSorted(), insertSortedOnce(), IntArray(), IntArray(), IntArray(), IntArray(), isAllFinite(), isEmpty(), maximum(), minimum(), minusOne(), operator=(), operator=(), operator=(), oofem::IntArrayF< T >::operator=(), operator[](), operator[](), preallocate(), resize(), resizeWithValues(), restoreYourself(), size(), storeYourself(), and zero().