OGS
|
The numerical algorithms used in OpenGeoSys
Namespaces | |
anonymous_namespace{DOFTableUtil.cpp} | |
anonymous_namespace{LocalToGlobalIndexMap.cpp} | |
detail | |
Enumerations | |
enum class | ComponentOrder { BY_COMPONENT , BY_LOCATION } |
Ordering of components in global matrix/vector. More... | |
enum class | ShapeMatrixType { N , DNDR , N_J , DNDR_J , DNDX , ALL } |
Shape matrix type to be calculated. More... | |
enum class | IterationResult : char { SUCCESS , FAILURE , REPEAT_ITERATION } |
Status flags telling the NonlinearSolver if an iteration succeeded. More... | |
enum class | NonlinearSolverTag : bool { Picard , Newton } |
Tag used to specify which nonlinear solver will be used. More... | |
enum class | ODESystemTag : char { FirstOrderImplicitQuasilinear , NeumannBC } |
Tag used to specify the type of ODE. More... | |
Functions | |
NewtonRaphsonSolverParameters | createNewtonRaphsonSolverParameters (BaseLib::ConfigTree const &config) |
GlobalSparsityPattern | computeSparsityPattern (LocalToGlobalIndexMap const &dof_table, MeshLib::Mesh const &mesh) |
Computes a sparsity pattern for the given inputs. More... | |
double | getNonGhostNodalValue (GlobalVector const &x, MeshLib::Mesh const &mesh, NumLib::LocalToGlobalIndexMap const &dof_table, std::size_t const node_id, std::size_t const global_component_id) |
double | getNodalValue (GlobalVector const &x, MeshLib::Mesh const &mesh, NumLib::LocalToGlobalIndexMap const &dof_table, std::size_t const node_id, std::size_t const global_component_id) |
std::vector< GlobalIndexType > | getIndices (std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table) |
NumLib::LocalToGlobalIndexMap::RowColumnIndices | getRowColumnIndices (std::size_t const id, NumLib::LocalToGlobalIndexMap const &dof_table, std::vector< GlobalIndexType > &indices) |
double | norm (GlobalVector const &x, unsigned const global_component, MathLib::VecNormType norm_type, LocalToGlobalIndexMap const &dof_table, MeshLib::Mesh const &mesh) |
template<typename Functor > | |
void | transformVariableFromGlobalVector (GlobalVector const &input_vector, int const variable_id, NumLib::LocalToGlobalIndexMap const &local_to_global_index_map, MeshLib::PropertyVector< double > &output_vector, Functor mapFunction) |
void | cleanupGlobalMatrixProviders () |
std::ostream & | operator<< (std::ostream &os, LocalToGlobalIndexMap const &map) |
template<typename LocalAssemblerCollection , typename IntegrationPointValuesMethod > | |
ExtrapolatableLocalAssemblerCollection< LocalAssemblerCollection > | makeExtrapolatable (LocalAssemblerCollection const &local_assemblers, IntegrationPointValuesMethod integration_point_values_method) |
template<class T_N , class T_DNDR , class T_J , class T_DNDX > | |
std::ostream & | operator<< (std::ostream &os, const ShapeMatrices< T_N, T_DNDR, T_J, T_DNDX > &shape) |
template<typename ShapeFunction , typename ShapeMatricesType > | |
NumLib::TemplateIsoparametric< ShapeFunction, ShapeMatricesType > | createIsoparametricFiniteElement (MeshLib::Element const &e) |
template<typename ShapeFunction , typename ShapeMatricesType , int GlobalDim, ShapeMatrixType SelectedShapeMatrixType = ShapeMatrixType::ALL, typename PointContainer > | |
std::vector< typename ShapeMatricesType::ShapeMatrices, Eigen::aligned_allocator< typename ShapeMatricesType::ShapeMatrices > > | computeShapeMatrices (MeshLib::Element const &e, bool const is_axially_symmetric, PointContainer const &points) |
template<typename ShapeFunction , typename ShapeMatricesType , int GlobalDim, ShapeMatrixType SelectedShapeMatrixType = ShapeMatrixType::ALL, typename IntegrationMethod > | |
std::vector< typename ShapeMatricesType::ShapeMatrices, Eigen::aligned_allocator< typename ShapeMatricesType::ShapeMatrices > > | initShapeMatrices (MeshLib::Element const &e, bool const is_axially_symmetric, IntegrationMethod const &integration_method) |
template<typename ShapeFunction , typename ShapeMatricesType > | |
double | interpolateXCoordinate (MeshLib::Element const &e, typename ShapeMatricesType::ShapeMatrices::ShapeType const &N) |
template<typename ShapeFunction , typename ShapeMatricesType > | |
std::array< double, 3 > | interpolateCoordinates (MeshLib::Element const &e, typename ShapeMatricesType::ShapeMatrices::ShapeType const &N) |
template<typename NodalValues , typename ShapeMatrix , typename... ScalarTypes> | |
void | shapeFunctionInterpolate (const NodalValues &nodal_values, const ShapeMatrix &shape_matrix_N, double &interpolated_value, ScalarTypes &... interpolated_values) |
template<typename LowerOrderShapeFunction , typename HigherOrderMeshElementType , int GlobalDim, typename EigenMatrixType > | |
void | interpolateToHigherOrderNodes (MeshLib::Element const &element, bool const is_axially_symmetric, Eigen::MatrixBase< EigenMatrixType > const &node_values, MeshLib::PropertyVector< double > &interpolated_values_global_vector) |
std::unique_ptr< ConvergenceCriterion > | createConvergenceCriterion (BaseLib::ConfigTree const &config) |
Creates a convergence criterion from the given configuration. More... | |
bool | checkRelativeTolerance (const double reltol, const double numerator, const double denominator) |
std::unique_ptr< ConvergenceCriterionDeltaX > | createConvergenceCriterionDeltaX (const BaseLib::ConfigTree &config) |
std::unique_ptr< ConvergenceCriterionPerComponentDeltaX > | createConvergenceCriterionPerComponentDeltaX (const BaseLib::ConfigTree &config) |
std::unique_ptr< ConvergenceCriterionPerComponentResidual > | createConvergenceCriterionPerComponentResidual (const BaseLib::ConfigTree &config) |
std::unique_ptr< ConvergenceCriterionResidual > | createConvergenceCriterionResidual (const BaseLib::ConfigTree &config) |
template<ODESystemTag ODETag> | |
std::unique_ptr< MatrixTranslator< ODETag > > | createMatrixTranslator (TimeDiscretization const &timeDisc) |
std::pair< std::unique_ptr< NonlinearSolverBase >, NonlinearSolverTag > | createNonlinearSolver (GlobalLinearSolver &linear_solver, BaseLib::ConfigTree const &config) |
std::unique_ptr< TimeDiscretization > | createTimeDiscretization (BaseLib::ConfigTree const &config) |
std::unique_ptr< TimeStepAlgorithm > | createEvolutionaryPIDcontroller (BaseLib::ConfigTree const &config) |
std::unique_ptr< TimeStepAlgorithm > | createFixedTimeStepping (BaseLib::ConfigTree const &config) |
std::unique_ptr< TimeStepAlgorithm > | createIterationNumberBasedTimeStepping (BaseLib::ConfigTree const &config) |
double | possiblyClampDtToNextFixedTime (double const t, double const dt, std::vector< double > const &fixed_output_times) |
std::unique_ptr< TimeStepAlgorithm > | createTimeStepper (BaseLib::ConfigTree const &config) |
|
strong |
Ordering of components in global matrix/vector.
Enumerator | |
---|---|
BY_COMPONENT | Ordering data by component type. |
BY_LOCATION | Ordering data by spatial location. |
Definition at line 22 of file MeshComponentMap.h.
|
strong |
Shape matrix type to be calculated.
Enumerator | |
---|---|
N | calculates N |
DNDR | calculates dNdr |
N_J | calculates N, dNdr, J, and detJ |
DNDR_J | calculates dNdr, J, and detJ |
DNDX | calculates dNdr, J, detJ, invJ, and dNdx |
ALL | calculates all |
Definition at line 23 of file ShapeMatrices.h.
bool NumLib::checkRelativeTolerance | ( | double const | reltol, |
double const | numerator, | ||
double const | denominator | ||
) |
Returns if |numerator/denominator| < |reltol|. This method copes with the case that denominator = 0 by always adding epsilon to the denominator.
Definition at line 48 of file ConvergenceCriterion.cpp.
Referenced by NumLib::ConvergenceCriterionDeltaX::checkDeltaX(), NumLib::ConvergenceCriterionPerComponentDeltaX::checkDeltaX(), NumLib::ConvergenceCriterionPerComponentResidual::checkResidual(), and NumLib::ConvergenceCriterionResidual::checkResidual().
void NumLib::cleanupGlobalMatrixProviders | ( | ) |
Definition at line 34 of file GlobalMatrixProviders.cpp.
Referenced by ApplicationsLib::LinearSolverLibrarySetup::~LinearSolverLibrarySetup().
std::vector<typename ShapeMatricesType::ShapeMatrices, Eigen::aligned_allocator<typename ShapeMatricesType::ShapeMatrices> > NumLib::computeShapeMatrices | ( | MeshLib::Element const & | e, |
bool const | is_axially_symmetric, | ||
PointContainer const & | points | ||
) |
Definition at line 24 of file InitShapeMatrices.h.
References MeshLib::Element::getDimension().
Referenced by NumLib::TemplateIsoparametric< ShapeFunctionType_, ShapeMatrixTypes_ >::computeShapeFunctions(), ProcessLib::LiquidFlow::LiquidFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::getFlux(), ProcessLib::SteadyStateDiffusion::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getFlux(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getFlux(), ProcessLib::HT::HTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::getFlux(), initShapeMatrices(), and interpolateToHigherOrderNodes().
GlobalSparsityPattern NumLib::computeSparsityPattern | ( | LocalToGlobalIndexMap const & | dof_table, |
MeshLib::Mesh const & | mesh | ||
) |
Computes a sparsity pattern for the given inputs.
dof_table | maps mesh nodes to global indices |
mesh | mesh for which the two parameters above are defined |
Definition at line 74 of file ComputeSparsityPattern.cpp.
References computeSparsityPatternPETSc().
Referenced by ProcessLib::Process::computeSparsityPattern(), ProcessLib::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::constructDofTable(), ProcessLib::PhaseField::PhaseFieldProcess< DisplacementDim >::constructDofTable(), ProcessLib::RichardsMechanics::RichardsMechanicsProcess< DisplacementDim >::constructDofTable(), ProcessLib::ThermoHydroMechanics::ThermoHydroMechanicsProcess< DisplacementDim >::constructDofTable(), ProcessLib::ThermoMechanicalPhaseField::ThermoMechanicalPhaseFieldProcess< DisplacementDim >::constructDofTable(), and ProcessLib::ThermoMechanics::ThermoMechanicsProcess< DisplacementDim >::constructDofTable().
std::unique_ptr< ConvergenceCriterion > NumLib::createConvergenceCriterion | ( | const BaseLib::ConfigTree & | config | ) |
Creates a convergence criterion from the given configuration.
Definition at line 22 of file ConvergenceCriterion.cpp.
References createConvergenceCriterionDeltaX(), createConvergenceCriterionPerComponentDeltaX(), createConvergenceCriterionPerComponentResidual(), createConvergenceCriterionResidual(), OGS_FATAL, and BaseLib::ConfigTree::peekConfigParameter().
Referenced by ProcessLib::createPerProcessData(), and ProcessLib::createTimeLoop().
std::unique_ptr< ConvergenceCriterionDeltaX > NumLib::createConvergenceCriterionDeltaX | ( | const BaseLib::ConfigTree & | config | ) |
Definition at line 61 of file ConvergenceCriterionDeltaX.cpp.
References BaseLib::ConfigTree::checkConfigParameter(), MathLib::convertStringToVecNormType(), BaseLib::ConfigTree::getConfigParameter(), BaseLib::ConfigTree::getConfigParameterOptional(), MathLib::INVALID, and OGS_FATAL.
Referenced by createConvergenceCriterion().
std::unique_ptr< ConvergenceCriterionPerComponentDeltaX > NumLib::createConvergenceCriterionPerComponentDeltaX | ( | const BaseLib::ConfigTree & | config | ) |
Definition at line 91 of file ConvergenceCriterionPerComponentDeltaX.cpp.
References BaseLib::ConfigTree::checkConfigParameter(), MathLib::convertStringToVecNormType(), BaseLib::ConfigTree::getConfigParameter(), BaseLib::ConfigTree::getConfigParameterOptional(), MathLib::INVALID, and OGS_FATAL.
Referenced by createConvergenceCriterion().
std::unique_ptr< ConvergenceCriterionPerComponentResidual > NumLib::createConvergenceCriterionPerComponentResidual | ( | const BaseLib::ConfigTree & | config | ) |
Definition at line 128 of file ConvergenceCriterionPerComponentResidual.cpp.
References BaseLib::ConfigTree::checkConfigParameter(), MathLib::convertStringToVecNormType(), BaseLib::ConfigTree::getConfigParameter(), BaseLib::ConfigTree::getConfigParameterOptional(), MathLib::INVALID, and OGS_FATAL.
Referenced by createConvergenceCriterion().
std::unique_ptr< ConvergenceCriterionResidual > NumLib::createConvergenceCriterionResidual | ( | const BaseLib::ConfigTree & | config | ) |
Definition at line 95 of file ConvergenceCriterionResidual.cpp.
References BaseLib::ConfigTree::checkConfigParameter(), MathLib::convertStringToVecNormType(), BaseLib::ConfigTree::getConfigParameter(), BaseLib::ConfigTree::getConfigParameterOptional(), MathLib::INVALID, and OGS_FATAL.
Referenced by createConvergenceCriterion().
std::unique_ptr< TimeStepAlgorithm > NumLib::createEvolutionaryPIDcontroller | ( | BaseLib::ConfigTree const & | config | ) |
Create an EvolutionaryPIDcontroller time stepper from the given configuration
Definition at line 22 of file CreateEvolutionaryPIDcontroller.cpp.
References BaseLib::ConfigTree::checkConfigParameter(), and BaseLib::ConfigTree::getConfigParameter().
Referenced by createTimeStepper().
std::unique_ptr< TimeStepAlgorithm > NumLib::createFixedTimeStepping | ( | BaseLib::ConfigTree const & | config | ) |
Create a FixedTimeStepping time stepper from the given configuration
Definition at line 24 of file CreateFixedTimeStepping.cpp.
References BaseLib::ConfigTree::checkConfigParameter(), BaseLib::ConfigTree::getConfigParameter(), BaseLib::ConfigTree::getConfigSubtree(), BaseLib::ConfigTree::getConfigSubtreeList(), and OGS_FATAL.
Referenced by createTimeStepper().
NumLib::TemplateIsoparametric<ShapeFunction, ShapeMatricesType> NumLib::createIsoparametricFiniteElement | ( | MeshLib::Element const & | e | ) |
Creates a TemplateIsoparametric element for the given shape functions and the underlying mesh element.
Definition at line 168 of file TemplateIsoparametric.h.
Referenced by ProcessLib::PythonBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), and ProcessLib::SourceTerms::Python::PythonSourceTermLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble().
std::unique_ptr< TimeStepAlgorithm > NumLib::createIterationNumberBasedTimeStepping | ( | BaseLib::ConfigTree const & | config | ) |
Create a IterationNumberBasedTimeStepping time stepper from the given configuration.
Definition at line 22 of file CreateIterationNumberBasedTimeStepping.cpp.
References BaseLib::ConfigTree::checkConfigParameter(), and BaseLib::ConfigTree::getConfigParameter().
Referenced by createTimeStepper().
NewtonRaphsonSolverParameters NumLib::createNewtonRaphsonSolverParameters | ( | BaseLib::ConfigTree const & | config | ) |
Definition at line 17 of file CreateNewtonRaphsonSolverParameters.cpp.
References DBUG(), BaseLib::ConfigTree::getConfigParameter(), BaseLib::ConfigTree::getConfigParameterOptional(), and WARN().
Referenced by MaterialLib::Fracture::createCoulomb(), MaterialLib::Solids::Creep::createCreepBGRa(), MaterialLib::Solids::Ehlers::createEhlers(), MaterialLib::Solids::Lubby2::createLubby2(), and ProcessLib::RichardsMechanics::createRichardsMechanicsProcess().
std::unique_ptr< TimeDiscretization > NumLib::createTimeDiscretization | ( | BaseLib::ConfigTree const & | config | ) |
Definition at line 19 of file TimeDiscretizationBuilder.cpp.
References BaseLib::ConfigTree::getConfigParameter(), and OGS_FATAL.
Referenced by ProcessLib::createPerProcessData().
std::unique_ptr< TimeStepAlgorithm > NumLib::createTimeStepper | ( | BaseLib::ConfigTree const & | config | ) |
Definition at line 26 of file CreateTimeStepper.cpp.
References createEvolutionaryPIDcontroller(), createFixedTimeStepping(), createIterationNumberBasedTimeStepping(), BaseLib::ConfigTree::ignoreConfigParameter(), OGS_FATAL, and BaseLib::ConfigTree::peekConfigParameter().
Referenced by ProcessLib::createPerProcessData().
std::vector< GlobalIndexType > NumLib::getIndices | ( | std::size_t const | mesh_item_id, |
NumLib::LocalToGlobalIndexMap const & | dof_table | ||
) |
Returns nodal indices for the item identified by mesh_item_id
from the given dof_table
.
Definition at line 124 of file DOFTableUtil.cpp.
References MaterialPropertyLib::c, NumLib::LocalToGlobalIndexMap::getNumberOfGlobalComponents(), and NumLib::LocalToGlobalIndexMap::size().
Referenced by ProcessLib::PythonBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::NormalTractionBoundaryCondition::NormalTractionBoundaryConditionLocalAssembler< ShapeFunctionDisplacement, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::NeumannBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::RobinBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::VectorMatrixAssembler::assemble(), ProcessLib::HCNonAdvectiveFreeComponentFlowBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::VariableDependentNeumannBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::SourceTerms::Python::PythonSourceTermLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::ComponentTransport::ComponentTransportLocalAssemblerInterface::assembleReactionEquation(), ProcessLib::VectorMatrixAssembler::assembleWithJacobian(), ProcessLib::SmallDeformationNonlocal::SmallDeformationNonlocalLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::computeCrackIntegral(), ProcessLib::LocalAssemblerInterface::computeSecondaryVariable(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::HT::MonolithicHTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::HT::StaggeredHTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::getIntPtDarcyVelocity(), ProcessLib::RichardsComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::RichardsFlow::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::SteadyStateDiffusion::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::TES::TESLocalAssembler< ShapeFunction_, IntegrationMethod_, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::ThermoHydroMechanics::ThermoHydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::getIntPtDarcyVelocity(), ProcessLib::LiquidFlow::LiquidFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::getIntPtDarcyVelocityGas(), ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::getIntPtDarcyVelocityLiquid(), ProcessLib::RichardsComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtSaturation(), ProcessLib::ComponentTransport::ComponentTransportLocalAssemblerInterface::initializeChemicalSystem(), ProcessLib::VolumetricSourceTermLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::integrate(), ProcessLib::LocalAssemblerInterface::postNonLinearSolver(), ProcessLib::LocalAssemblerInterface::postTimestep(), ProcessLib::VectorMatrixAssembler::preAssemble(), ProcessLib::LocalAssemblerInterface::preTimestep(), ProcessLib::ComponentTransport::ComponentTransportLocalAssemblerInterface::setChemicalSystem(), ProcessLib::LocalAssemblerInterface::setInitialConditions(), and ProcessLib::SmallDeformation::writeMaterialForces().
double NumLib::getNodalValue | ( | GlobalVector const & | x, |
MeshLib::Mesh const & | mesh, | ||
NumLib::LocalToGlobalIndexMap const & | dof_table, | ||
std::size_t const | node_id, | ||
std::size_t const | global_component_id | ||
) |
Returns the value for the given node_id
and global_component_id
from the vector x
.
Definition at line 110 of file DOFTableUtil.cpp.
References MathLib::EigenVector::get(), NumLib::LocalToGlobalIndexMap::getGlobalIndex(), MeshLib::Mesh::getID(), MeshLib::Node, and NumLib::MeshComponentMap::nop.
Referenced by ProcessLib::TES::TESProcess::computeEquilibriumLoading(), ProcessLib::TES::TESProcess::computeRelativeHumidity(), and ProcessLib::TES::TESProcess::computeVapourPartialPressure().
double NumLib::getNonGhostNodalValue | ( | GlobalVector const & | x, |
MeshLib::Mesh const & | mesh, | ||
NumLib::LocalToGlobalIndexMap const & | dof_table, | ||
std::size_t const | node_id, | ||
std::size_t const | global_component_id | ||
) |
Returns the value for the given node_id
and global_component_id
from the vector x
in case the node is not a ghost node. Else 0.0 is returned.
Definition at line 91 of file DOFTableUtil.cpp.
References MathLib::EigenVector::get(), NumLib::LocalToGlobalIndexMap::getGlobalIndex(), MeshLib::Mesh::getID(), MeshLib::Node, and NumLib::MeshComponentMap::nop.
Referenced by NumLib::anonymous_namespace{DOFTableUtil.cpp}::norm().
LocalToGlobalIndexMap::RowColumnIndices NumLib::getRowColumnIndices | ( | std::size_t const | id, |
NumLib::LocalToGlobalIndexMap const & | dof_table, | ||
std::vector< GlobalIndexType > & | indices | ||
) |
Returns row/column indices for the item identified by id
from the given dof_table
.
Definition at line 143 of file DOFTableUtil.cpp.
References MaterialPropertyLib::c, NumLib::LocalToGlobalIndexMap::getNumberOfGlobalComponents(), and NumLib::LocalToGlobalIndexMap::size().
Referenced by ProcessLib::ComponentTransport::ComponentTransportProcess::getFlux(), ProcessLib::LiquidFlow::LiquidFlowProcess::getFlux(), ProcessLib::HT::HTProcess::getFlux(), ProcessLib::SteadyStateDiffusion::SteadyStateDiffusion::getFlux(), and ProcessLib::TES::TESProcess::postIterationConcreteProcess().
std::vector<typename ShapeMatricesType::ShapeMatrices, Eigen::aligned_allocator<typename ShapeMatricesType::ShapeMatrices> > NumLib::initShapeMatrices | ( | MeshLib::Element const & | e, |
bool const | is_axially_symmetric, | ||
IntegrationMethod const & | integration_method | ||
) |
Definition at line 53 of file InitShapeMatrices.h.
References computeShapeMatrices().
Referenced by ProcessLib::ConstraintDirichletBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::ConstraintDirichletBoundaryConditionLocalAssembler(), ProcessLib::HeatTransportBHE::HeatTransportBHELocalAssemblerBHE< ShapeFunction, IntegrationMethod, BHEType >::HeatTransportBHELocalAssemblerBHE(), ProcessLib::HeatTransportBHE::HeatTransportBHELocalAssemblerSoil< ShapeFunction, IntegrationMethod >::HeatTransportBHELocalAssemblerSoil(), ProcessLib::HT::HTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::HTFEM(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::HydroMechanicsLocalAssembler(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerFracture< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, GlobalDim >::HydroMechanicsLocalAssemblerFracture(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerMatrix< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, GlobalDim >::HydroMechanicsLocalAssemblerMatrix(), ProcessLib::LiquidFlow::LiquidFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::LiquidFlowLocalAssembler(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::LocalAssemblerData(), ProcessLib::RichardsFlow::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::LocalAssemblerData(), ProcessLib::StokesFlow::LocalAssemblerData< ShapeFunctionLiquidVelocity, ShapeFunctionPressure, IntegrationMethod, GlobalDim >::LocalAssemblerData(), ProcessLib::NormalTractionBoundaryCondition::NormalTractionBoundaryConditionLocalAssembler< ShapeFunctionDisplacement, IntegrationMethod, GlobalDim >::NormalTractionBoundaryConditionLocalAssembler(), ProcessLib::PhaseField::PhaseFieldLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::PhaseFieldLocalAssembler(), ProcessLib::SourceTerms::Python::PythonSourceTermLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::PythonSourceTermLocalAssembler(), ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::RichardsMechanicsLocalAssembler(), ProcessLib::SmallDeformation::SmallDeformationLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::SmallDeformationLocalAssembler(), ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrix< ShapeFunction, IntegrationMethod, DisplacementDim >::SmallDeformationLocalAssemblerMatrix(), ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, IntegrationMethod, DisplacementDim >::SmallDeformationLocalAssemblerMatrixNearFracture(), ProcessLib::SmallDeformationNonlocal::SmallDeformationNonlocalLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::SmallDeformationNonlocalLocalAssembler(), ProcessLib::SurfaceFluxLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::SurfaceFluxLocalAssembler(), ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::TH2MLocalAssembler(), ProcessLib::ThermalTwoPhaseFlowWithPP::ThermalTwoPhaseFlowWithPPLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::ThermalTwoPhaseFlowWithPPLocalAssembler(), ProcessLib::ThermoHydroMechanics::ThermoHydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::ThermoHydroMechanicsLocalAssembler(), ProcessLib::ThermoMechanicalPhaseField::ThermoMechanicalPhaseFieldLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::ThermoMechanicalPhaseFieldLocalAssembler(), ProcessLib::ThermoMechanics::ThermoMechanicsLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::ThermoMechanicsLocalAssembler(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunction, IntegrationMethod, DisplacementDim >::ThermoRichardsMechanicsLocalAssembler(), ProcessLib::TwoPhaseFlowWithPP::TwoPhaseFlowWithPPLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::TwoPhaseFlowWithPPLocalAssembler(), ProcessLib::VolumetricSourceTermLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::VolumetricSourceTermLocalAssembler(), and ProcessLib::GenericNaturalBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::initNsAndWeights().
std::array<double, 3> NumLib::interpolateCoordinates | ( | MeshLib::Element const & | e, |
typename ShapeMatricesType::ShapeMatrices::ShapeType const & | N | ||
) |
Definition at line 82 of file InitShapeMatrices.h.
References N.
Referenced by ProcessLib::NeumannBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::RobinBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::initializeConcrete(), ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::initializeConcrete(), ProcessLib::SmallDeformation::SmallDeformationLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::initializeConcrete(), ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::initializeConcrete(), ProcessLib::ThermoHydroMechanics::ThermoHydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::initializeConcrete(), ProcessLib::ThermoMechanics::ThermoMechanicsLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::initializeConcrete(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunction, IntegrationMethod, DisplacementDim >::initializeConcrete(), and ProcessLib::VolumetricSourceTermLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::integrate().
void NumLib::interpolateToHigherOrderNodes | ( | MeshLib::Element const & | element, |
bool const | is_axially_symmetric, | ||
Eigen::MatrixBase< EigenMatrixType > const & | node_values, | ||
MeshLib::PropertyVector< double > & | interpolated_values_global_vector | ||
) |
Interpolates scalar node_values
given in lower order element nodes (e.g. the base nodes) to higher order element's nodes (e.g. quadratic nodes) and writes the result into the global property vector.
The base nodes' values are copied. For each higher order node the shape matrices are evaluated for the lower order element (the base nodes), and used for the the scalar quantity interpolation.
Definition at line 106 of file Interpolation.h.
References computeShapeMatrices(), MeshLib::getNodeIndex(), MeshLib::Element::getNumberOfBaseNodes(), MeshLib::Element::getNumberOfNodes(), and N.
Referenced by ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::ThermoHydroMechanics::ThermoHydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunction, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::StokesFlow::LocalAssemblerData< ShapeFunctionLiquidVelocity, ShapeFunctionPressure, IntegrationMethod, GlobalDim >::computeSecondaryVariableConcrete(), and ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerMatrix< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, GlobalDim >::postTimestepConcreteWithBlockVectors().
double NumLib::interpolateXCoordinate | ( | MeshLib::Element const & | e, |
typename ShapeMatricesType::ShapeMatrices::ShapeType const & | N | ||
) |
Definition at line 71 of file InitShapeMatrices.h.
References N.
Referenced by ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assemble(), ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assemble(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerMatrix< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, GlobalDim >::assembleBlockMatricesWithJacobian(), ProcessLib::SmallDeformation::SmallDeformationLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::ThermoHydroMechanics::ThermoHydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunction, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::SmallDeformationNonlocal::SmallDeformationNonlocalLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assembleWithJacobianForDeformationEquations(), ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunction, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::SmallDeformationNonlocal::SmallDeformationNonlocalLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::getNodalValues(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::postNonLinearSolverConcrete(), ProcessLib::ThermoHydroMechanics::ThermoHydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::postNonLinearSolverConcrete(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerMatrix< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, GlobalDim >::postTimestepConcreteWithBlockVectors(), ProcessLib::SmallDeformationNonlocal::SmallDeformationNonlocalLocalAssembler< ShapeFunction, IntegrationMethod, DisplacementDim >::preAssemble(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::setInitialConditionsConcrete(), and ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::updateConstitutiveVariables().
ExtrapolatableLocalAssemblerCollection<LocalAssemblerCollection> NumLib::makeExtrapolatable | ( | LocalAssemblerCollection const & | local_assemblers, |
IntegrationPointValuesMethod | integration_point_values_method | ||
) |
Creates an ExtrapolatableLocalAssemblerCollection, which can be used to provide information to an Extrapolator.
Definition at line 149 of file ExtrapolatableElementCollection.h.
Referenced by ProcessLib::ComponentTransport::ComponentTransportProcess::extrapolateIntegrationPointValuesToNodes(), and ProcessLib::makeExtrapolator().
double NumLib::norm | ( | GlobalVector const & | x, |
unsigned const | global_component, | ||
MathLib::VecNormType | norm_type, | ||
LocalToGlobalIndexMap const & | dof_table, | ||
MeshLib::Mesh const & | mesh | ||
) |
Computes the specified norm of the given global component of the given vector x.
x
is typically the solution vector of a monolithically coupled process with several primary variables. Definition at line 163 of file DOFTableUtil.cpp.
References MathLib::INFINITY_N, MathLib::NORM1, NumLib::anonymous_namespace{DOFTableUtil.cpp}::norm1(), MathLib::NORM2, NumLib::anonymous_namespace{DOFTableUtil.cpp}::norm2(), NumLib::anonymous_namespace{DOFTableUtil.cpp}::normInfinity(), and OGS_FATAL.
Referenced by NumLib::ConvergenceCriterionPerComponentDeltaX::checkDeltaX(), NumLib::ConvergenceCriterionPerComponentResidual::checkDeltaX(), NumLib::ConvergenceCriterionPerComponentResidual::checkResidual(), NumLib::anonymous_namespace{DOFTableUtil.cpp}::norm1(), NumLib::anonymous_namespace{DOFTableUtil.cpp}::norm2(), and NumLib::anonymous_namespace{DOFTableUtil.cpp}::normInfinity().
std::ostream& NumLib::operator<< | ( | std::ostream & | os, |
const ShapeMatrices< T_N, T_DNDR, T_J, T_DNDX > & | shape | ||
) |
Definition at line 129 of file ShapeMatrices-impl.h.
References NumLib::ShapeMatrices< T_N, T_DNDR, T_J, T_DNDX >::write().
std::ostream& NumLib::operator<< | ( | std::ostream & | os, |
LocalToGlobalIndexMap const & | map | ||
) |
Definition at line 453 of file LocalToGlobalIndexMap.cpp.
double NumLib::possiblyClampDtToNextFixedTime | ( | double const | t, |
double const | dt, | ||
std::vector< double > const & | fixed_output_times | ||
) |
If any of the fixed times will be reached with given time increment, it will be reduced, otherwise the input will be returned.
t | Current time. |
dt | Suggested time increment. |
fixed_output_times | Sorted list of times which are to be reached. |
Definition at line 17 of file TimeStepAlgorithm.cpp.
Referenced by ProcessLib::TimeLoop::computeTimeStepping().
void NumLib::shapeFunctionInterpolate | ( | const NodalValues & | nodal_values, |
const ShapeMatrix & | shape_matrix_N, | ||
double & | interpolated_value, | ||
ScalarTypes &... | interpolated_values | ||
) |
Interpolates variables given at element nodes according to the given shape matrix.
This function simply does the usual finite-element interpolation, i.e. multiplication of nodal values with the shape function.
nodal_values | vector of nodal values, ordered by component |
shape_matrix_N | shape matrix of the point to which will be interpolated |
interpolated_value | interpolated value of the first d.o.f. (output parameter) |
interpolated_values | interpolated value of further d.o.f. (output parameter) |
NodalValues | type of the container where nodal values are stored |
ShapeMatrix | type of the shape matrix \(N\). |
ScalarValues | all of the types in this pack must currently be double . |
nodal_values
have to be ordered by component and it is assumed that all passed d.o.f. are single-component and are interpolated using the same shape function. Definition at line 79 of file Interpolation.h.
Referenced by ProcessLib::SteadyStateDiffusion::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::StokesFlow::LocalAssemblerData< ShapeFunctionLiquidVelocity, ShapeFunctionPressure, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::HT::MonolithicHTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::RichardsFlow::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::RichardsComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::ThermalTwoPhaseFlowWithPP::ThermalTwoPhaseFlowWithPPLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::TwoPhaseFlowWithPP::TwoPhaseFlowWithPPLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assemble(), ProcessLib::ThermoRichardsFlow::ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::TwoPhaseFlowWithPrho::TwoPhaseFlowWithPrhoLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::HeatTransportBHE::HeatTransportBHELocalAssemblerSoil< ShapeFunction, IntegrationMethod >::assemble(), ProcessLib::HCNonAdvectiveFreeComponentFlowBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::VariableDependentNeumannBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assemble(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::assembleBlockMatrices(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::assembleComponentTransportEquation(), ProcessLib::HT::StaggeredHTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::assembleHeatTransportEquation(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::assembleHydraulicEquation(), ProcessLib::HT::StaggeredHTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::assembleHydraulicEquation(), ProcessLib::LiquidFlow::LiquidFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assembleMatrixAndVector(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::assembleReactionEquationConcrete(), ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::ThermoRichardsFlow::ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::assembleWithJacobian(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunction, IntegrationMethod, DisplacementDim >::assembleWithJacobian(), ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::assembleWithJacobianForDeformationEquations(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::calculateIntPtDarcyVelocity(), ProcessLib::LiquidFlow::LiquidFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::computeProjectedDarcyVelocity(), ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::ThermoRichardsFlow::ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::computeSecondaryVariableConcrete(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunction, IntegrationMethod, DisplacementDim >::computeSecondaryVariableConcrete(), ProcessLib::LiquidFlow::LiquidFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::getFlux(), ProcessLib::SteadyStateDiffusion::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getFlux(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getFlux(), ProcessLib::HT::HTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::getFlux(), ProcessLib::RichardsComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::RichardsFlow::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::SteadyStateDiffusion::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::TES::TESLocalAssembler< ShapeFunction_, IntegrationMethod_, GlobalDim >::getIntPtDarcyVelocity(), ProcessLib::HT::HTFEM< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtDarcyVelocityLocal(), ProcessLib::RichardsComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::getIntPtSaturation(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::initializeChemicalSystemConcrete(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::interpolateNodalValuesToIntegrationPoints(), ProcessLib::TES::TESLocalAssemblerInner< Traits >::preEachAssembleIntegrationPoint(), ProcessLib::ComponentTransport::LocalAssemblerData< ShapeFunction, IntegrationMethod, GlobalDim >::setChemicalSystemConcrete(), ProcessLib::RichardsMechanics::RichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, IntegrationMethod, DisplacementDim >::setInitialConditionsConcrete(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunction, IntegrationMethod, DisplacementDim >::setInitialConditionsConcrete(), and ProcessLib::ThermoRichardsFlow::ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim >::setInitialConditionsConcrete().
void NumLib::transformVariableFromGlobalVector | ( | GlobalVector const & | input_vector, |
int const | variable_id, | ||
NumLib::LocalToGlobalIndexMap const & | local_to_global_index_map, | ||
MeshLib::PropertyVector< double > & | output_vector, | ||
Functor | mapFunction | ||
) |
Copies part of a global vector for the given variable into output_vector while applying a function to each value.
Definition at line 59 of file DOFTableUtil.h.
References MeshLib::PropertyVector< PROP_VAL_TYPE >::getComponent(), NumLib::LocalToGlobalIndexMap::getGlobalIndex(), MeshLib::MeshSubset::getMeshID(), NumLib::LocalToGlobalIndexMap::getMeshSubset(), NumLib::LocalToGlobalIndexMap::getNumberOfVariableComponents(), MeshLib::Node, and MathLib::LinAlg::setLocalAccessibleVector().
Referenced by ProcessLib::LiquidFlow::LiquidFlowProcess::assembleConcreteProcess(), ProcessLib::HeatConduction::HeatConductionProcess::assembleConcreteProcess(), ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< GlobalDim >::assembleWithJacobianConcreteProcess(), ProcessLib::RichardsMechanics::RichardsMechanicsProcess< DisplacementDim >::assembleWithJacobianConcreteProcess(), ProcessLib::SmallDeformation::SmallDeformationProcess< DisplacementDim >::assembleWithJacobianConcreteProcess(), ProcessLib::TH2M::TH2MProcess< DisplacementDim >::assembleWithJacobianConcreteProcess(), ProcessLib::ThermoHydroMechanics::ThermoHydroMechanicsProcess< DisplacementDim >::assembleWithJacobianConcreteProcess(), ProcessLib::ThermoMechanics::ThermoMechanicsProcess< DisplacementDim >::assembleWithJacobianConcreteProcess(), ProcessLib::ThermoRichardsFlow::ThermoRichardsFlowProcess::assembleWithJacobianConcreteProcess(), ProcessLib::ThermoRichardsMechanics::ThermoRichardsMechanicsProcess< DisplacementDim >::assembleWithJacobianConcreteProcess(), ProcessLib::HeatConduction::HeatConductionProcess::assembleWithJacobianConcreteProcess(), and ProcessLib::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::assembleWithJacobianConcreteProcess().