OOFEM 3.0
Loading...
Searching...
No Matches
classfactory.C File Reference
#include "classfactory.h"
#include <string>
#include <algorithm>
#include <cctype>
#include "engngm.h"
#include "masterdof.h"
#include "slavedof.h"
#include "simpleslavedof.h"
#include "activedof.h"
#include "sparsemtrx.h"
#include "sparsegeneigenvalsystemnm.h"
#include "sparsenonlinsystemnm.h"
#include "sparselinsystemnm.h"
#include "mesherinterface.h"
#include "errorestimator.h"
#include "materialmappingalgorithm.h"
#include "function.h"
#include "material.h"
#include "crosssection.h"
#include "nonlocalbarrier.h"
#include "exportmodule.h"
#include "initmodule.h"
#include "loadbalancer.h"
#include "gaussintegrationrule.h"
#include "lobattoir.h"
#include "initialcondition.h"
#include "xfem/nucleationcriterion.h"
#include "xfem/xfemmanager.h"
#include "xfem/enrichmentfunction.h"
#include "xfem/enrichmentitem.h"
#include "xfem/propagationlaw.h"
#include "topologydescription.h"
#include "geometry.h"
#include "fracturemanager.h"
#include "Contact/contactsurface.h"
#include "feinterpol.h"
#include "../mpm/mpm.h"
#include "timestepreductionstrategy.h"

Go to the source code of this file.

Namespaces

namespace  oofem

Macros

#define N(a, b)
#define E(a, b)

Functions

std::string oofem::conv2lower (std ::string input)
template<typename C, typename T, typename V, typename ... As>
C * oofem::cf_create2 (const T &list, V name, As ... args)
template<typename T, typename V, typename C>
bool oofem::cf_store2 (T &list, V name, C &creator)
template<typename C, typename T, typename V, typename ... As>
std::unique_ptr< C > oofem::cf_create4 (const T &list, V name, As ... args)
template<typename C, typename T, typename ... As>
std::unique_ptr< C > oofem::cf_create (const T &list, const char *name, As ... args)
template<typename T, typename C>
bool oofem::cf_store (T &list, const char *name, C &creator)

Macros for registering new components. Unique dummy variables must be created as a result (design flaw in C++).

ClassFactoryoofem::classFactory = GiveClassFactory()
ClassFactoryoofem::GiveClassFactory ()

Macro Definition Documentation

◆ E

#define E ( a,
b )
Value:
{ auto& l=ret[#a]; for(const auto& kv: b) l.push_back(std::to_string((int)kv.first)); };

Referenced by oofem::CemhydMatStatus::AnalyticHomogenizationPaste(), oofem::ConcreteFCM::checkSnapBack(), oofem::ConcreteFCM::computeD2ModulusForCrack(), oofem::FRCFCM::computeD2ModulusForCrack(), oofem::IsotropicDamageMaterial1::computeDamageParamForCohesiveCrack(), oofem::SolidShell::computeEVector(), oofem::ConcreteFCM::computeNumerD2ModulusForCrack(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::CemhydMatStatus::constructor_init(), oofem::IsotropicDamageMaterial1::damageFunctionPrime(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::Homogenize::ENuToKMu(), oofem::FRCFCM::estimateD2ModulusForCrack(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncDerivAt(), oofem::ClassFactory::getRegisteredNames(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::IsotropicAsymmetric1DMaterial::give1dStressStiffMtrx(), oofem::MisesMat::give1dStressStiffMtrx(), oofem::MisesMatGrad::give1dStressStiffMtrx(), oofem::MisesMatNl::give1dStressStiffMtrx(), oofem::SimpleCrossSection::give3dBeamStiffMtrx(), oofem::ConcreteFCM::giveCrackingModulus(), oofem::ConcreteFCM::giveCrackingModulusInTension(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEModulus(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::StructuralMaterial::giveFirstPKStressVector_3d(), oofem::StructuralPythonMaterial::giveFirstPKStressVector_3d(), oofem::ConcreteFCM::giveNormalCrackingStress(), oofem::MisesMat::givePlaneStressStiffMtrx(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::MisesMat::giveRealStressVector_1d(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::IsotropicDamageMaterial1::initializeFrom(), oofem::Homogenize::kMuToENu(), oofem::FRCFCM::maxShearStress(), oofem::MisesMat::performPlasticityReturn(), oofem::MisesMat::performPlasticityReturn_PlaneStress(), oofem::tet21ghostsolid::tet21ghostsolid(), and oofem::MDM::transformStrainToPDC().

◆ N

#define N ( a,
b )
Value:
{ auto& l=ret[#a]; for(const auto& kv: b) l.push_back(kv.first); };

Referenced by oofem::PrescribedMean::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::FloatMatrix::assignFloatMatrixF(), oofem::TSplineInterpolation::basisFunction(), oofem::BSplineInterpolation::basisFuns(), oofem::Bmatrix_2d(), oofem::FEInterpolation3d::boundarySurfaceEvalNormal(), oofem::FloatMatrixF< N, M >::checkBounds(), oofem::column(), oofem::FloatMatrixF< N, M >::column(), oofem::Tensor2_3d::compute_dCm_dC_fromEigs(), oofem::HTSelement::computeAMatrixAt(), oofem::IntElLine1::computeAreaAround(), oofem::IntElLine1PhF::computeAreaAround(), oofem::AxisymElement::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::TR1_2D_PFEM::computeBodyLoadVectorAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::ConcreteFCM::computeD2ModulusForCrack(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::ConcreteFCM::computeEffectiveShearModulus(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::HTSelement::computeFMatrixAt(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::IntElSurfQuad1::computeGlobalCoordinates(), oofem::IntElSurfTr1::computeGlobalCoordinates(), oofem::MITC4Shell::computeGlobalCoordinates(), oofem::Shell7Base::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::StructuralPenaltyContactBoundaryCondition::computeInternalForcesFromContact(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::TransportElement::computeInternalForcesVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::TransportElement::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::Beam2d::computeLumpedInitialStressMatrix(), oofem::Beam3d::computeLumpedInitialStressMatrix(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::FCMMaterial::computeMaxNormalCrackOpening(), oofem::PhaseFieldElement::computeNd_matrixAt(), oofem::StructuralInterfaceElementPhF::computeNd_matrixAt(), oofem::IntElLine1PF::computeNd_vectorAt(), oofem::PlaneStressStructuralElementEvaluator::computeNMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeNMatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::IntElSurfQuad1::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::QDKTPlate::computeNmatrixAt(), oofem::Quad1PlateSubSoil::computeNmatrixAt(), oofem::Quad2PlateSubSoil::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::Tria1PlateSubSoil::computeNmatrixAt(), oofem::Tria2PlateSubSoil::computeNmatrixAt(), oofem::FCMMaterial::computeNormalCrackOpening(), oofem::StructuralInterfaceElementPhF::computeNStress_d(), oofem::ConcreteFCM::computeNumerD2ModulusForCrack(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::HTSelement::computePuVectorAt(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::Shell7Base::computeSectionalForces(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::HTSelement::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::PhaseFieldElement::computeStiffnessMatrix_du(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::Structural3DElement::computeSurfaceNMatrixAt(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::StructuralPenaltyContactBoundaryCondition::computeTangentFromContact(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::Shell7Base::computeTractionForce(), oofem::BoundaryLoad::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::diag(), oofem::diag(), oofem::dot(), oofem::dot(), oofem::dot(), oofem::dot(), oofem::dotT(), oofem::StructuralElementEvaluator::drawIGAPatchDeformedGeometry, oofem::dyad(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7Base::edgeComputeNmatrixAt(), oofem::Shell7Base::edgeEvalInitialDirectorAt(), oofem::FEI3dQuadLin::edgeLocal2global(), oofem::FEI3dTetQuad::edgeLocal2global(), oofem::FEI3dTrLin::edgeLocal2global(), oofem::FEI3dTrQuad::edgeLocal2global(), oofem::eig(), oofem::eig_inverse(), oofem::NURBSInterpolation::evaldNdx(), oofem::Shell7Base::evalInitialDirectorAt(), oofem::BSplineInterpolation::evalN(), oofem::NURBSInterpolation::evalN(), oofem::TSplineInterpolation::evalN(), oofem::InternalTMFluxSourceTerm::evaluate(), oofem::NTf_Body::evaluate(), oofem::NTf_Edge::evaluate(), oofem::NTf_Surface::evaluate(), oofem::NTfTerm::evaluate(), oofem::NdTdvfNpTerm::evaluate_lin(), oofem::NTmuVfSNTerm::evaluate_lin(), oofem::GeometryBasedEI::evaluateEnrFuncAt(), oofem::GeometryBasedEI::evaluateEnrFuncDerivAt(), oofem::GeometryBasedEI::evaluateEnrFuncJumps(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::eye(), oofem::FloatArrayF< N >::FloatArrayF(), oofem::FloatMatrixF< N, M >::FloatMatrixF(), oofem::FloatMatrixF< N, M >::fromColumns(), oofem::ClassFactory::getRegisteredNames(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector_d(), oofem::PhaseFieldElement::giveInternalForcesVector_u(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_u(), oofem::CoupledFieldsElement::giveInternalForcesVectorGen(), oofem::LIBeam3dBoundary::giveIPValue(), oofem::LTRSpaceBoundary::giveIPValue(), oofem::QPlaneStress2dSlip::giveIPValue(), oofem::QTrPlaneStress2dSlip::giveIPValue(), oofem::StructuralElement::giveIPValue(), oofem::tet21ghostsolid::giveIPValue(), oofem::Shell7Base::giveL2contribution(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::FCMMaterial::giveNumberOfCracksForShearDirection(), oofem::FCMMaterial::giveNumberOfCracksInDirection(), oofem::FloatMatrixF< N, M >::givePackSize(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::FEI2dQuadLinAxi::giveTransformationJacobian(), oofem::FEI2dQuadQuadAxi::giveTransformationJacobian(), oofem::FEI2dTrLinAxi::giveTransformationJacobian(), oofem::Shell7Base::giveUnknownsAt(), oofem::Grid::Grid(), oofem::Heap::Heap(), oofem::Homogenize::herveZaoui(), oofem::StokesFlowVelocityHomogenization::integrateNMatrix(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::inv(), oofem::Inclusion::isMaterialModified(), oofem::BSplineInterpolation::local2global(), oofem::FEI3dTetQuad::local2global(), oofem::NURBSInterpolation::local2global(), oofem::TSplineInterpolation::local2global(), oofem::max(), oofem::min(), oofem::mult(), oofem::Nmatrix(), oofem::IntElLine1::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::norm(), oofem::FloatMatrixF< N, M >::operator()(), oofem::FloatMatrixF< N, M >::operator()(), oofem::operator*(), oofem::operator+(), oofem::operator+=(), oofem::operator-(), oofem::operator-(), oofem::operator-=(), oofem::operator/(), oofem::operator<<(), oofem::operator^(), oofem::orthogonalize(), oofem::FloatMatrix::plus_Nt_a_otimes_b_B(), oofem::Triangle::pointIsInTriangle(), oofem::FloatMatrixF< N, M >::printYourself(), oofem::PLHoopStressCirc::propagateInterface(), oofem::PLPrincipalStrain::propagateInterface(), oofem::FloatMatrixF< N, M >::restoreYourself(), oofem::FloatMatrixF< N, M >::rows(), oofem::FloatMatrixF< N, M >::setColumn(), oofem::Heap::setToEmpty(), oofem::FloatArrayF< N >::size(), oofem::solve(), oofem::solve_check(), oofem::FloatMatrixF< N, M >::storeYourself(), oofem::FEInterpolation3d::surfaceGiveTransformationJacobian(), oofem::FEI3dQuadLin::surfaceLocal2global(), oofem::FEI3dTetQuad::surfaceLocal2global(), oofem::FEI3dTrLin::surfaceLocal2global(), oofem::FEI3dTrQuad::surfaceLocal2global(), oofem::Tdot(), oofem::EnrichmentItem::tipIsTouchingEI(), oofem::trace(), oofem::MDM::transformStrainToPDC(), oofem::transpose(), oofem::Quad10_2D_SUPG::updateStabilizationCoeffs(), oofem::TR21_2D_SUPG::updateStabilizationCoeffs(), oofem::Shell7Base::vtkEvalInitialGlobalCoordinateAt(), and oofem::Shell7Base::vtkEvalInitialGlobalCZCoordinateAt().


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