![]() |
OGS
|
|
Definition at line 159 of file HydroMechanicsFEM.h.
#include <HydroMechanicsFEM.h>
Public Types | |
| using | ShapeMatricesTypeDisplacement |
| using | ShapeMatricesTypePressure |
| using | Invariants = MathLib::KelvinVector::Invariants<KelvinVectorSize> |
| using | SymmetricTensor = Eigen::Matrix<double, KelvinVectorSize, 1> |
Public Member Functions | |
| HydroMechanicsLocalAssembler (HydroMechanicsLocalAssembler const &)=delete | |
| HydroMechanicsLocalAssembler (HydroMechanicsLocalAssembler &&)=delete | |
| HydroMechanicsLocalAssembler (MeshLib::Element const &e, std::size_t const, NumLib::GenericIntegrationMethod const &integration_method, bool const is_axially_symmetric, HydroMechanicsProcessData< DisplacementDim > &process_data) | |
| std::size_t | setIPDataInitialConditions (std::string_view const name, double const *values, int const integration_order) override |
| Returns number of read integration points. | |
| void | assemble (double const, double const, std::vector< double > const &, std::vector< double > const &, std::vector< double > &, std::vector< double > &, std::vector< double > &) override |
| void | assembleWithJacobian (double const t, double const dt, std::vector< double > const &local_x, std::vector< double > const &local_x_prev, std::vector< double > &local_rhs_data, std::vector< double > &local_Jac_data) override |
| void | assembleWithJacobianForStaggeredScheme (const double t, double const dt, Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, int const process_id, std::vector< double > &local_b_data, std::vector< double > &local_Jac_data) override |
| void | initializeConcrete () override |
| void | postTimestepConcrete (Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, double const t, double const dt, int const process_id) override |
| void | computeSecondaryVariableConcrete (double const t, double const dt, Eigen::VectorXd const &local_xs, Eigen::VectorXd const &local_x_prev) override |
| void | postNonLinearSolverConcrete (Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, double const t, double const dt, int const process_id) override |
| void | setInitialConditionsConcrete (Eigen::VectorXd const local_x, double const t, int const process_id) override |
| Eigen::Map< const Eigen::RowVectorXd > | getShapeMatrix (const unsigned integration_point) const override |
| Provides the shape matrix at the given integration point. | |
| std::vector< double > | getSigma () const override |
| std::vector< double > | getEpsilon () const override |
| std::vector< double > | getStrainRateVariable () const override |
| std::vector< double > const & | getIntPtDarcyVelocity (const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const override |
| std::vector< double > const & | getIntPtSigma (const double, std::vector< GlobalVector * > const &, std::vector< NumLib::LocalToGlobalIndexMap const * > const &, std::vector< double > &cache) const override |
| std::vector< double > const & | getIntPtEpsilon (const double, std::vector< GlobalVector * > const &, std::vector< NumLib::LocalToGlobalIndexMap const * > const &, std::vector< double > &cache) const override |
| int | getNumberOfVectorElementsForDeformation () const override |
| Public Member Functions inherited from ProcessLib::LocalAssemblerInterface | |
| virtual | ~LocalAssemblerInterface ()=default |
| virtual void | setInitialConditions (std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, double const t, int const process_id) |
| virtual void | initialize (std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table) |
| virtual void | preAssemble (double const, double const, std::vector< double > const &) |
| virtual void | assembleForStaggeredScheme (double const t, double const dt, Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, int const process_id, std::vector< double > &local_M_data, std::vector< double > &local_K_data, std::vector< double > &local_b_data) |
| virtual void | computeSecondaryVariable (std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_prev, int const process_id) |
| virtual void | preTimestep (std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table, GlobalVector const &x, double const t, double const delta_t) |
| virtual void | postTimestep (std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, double const t, double const dt, int const process_id) |
| void | postNonLinearSolver (std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, double const t, double const dt, int const process_id) |
| virtual Eigen::Vector3d | getFlux (MathLib::Point3d const &, double const, std::vector< double > const &) const |
| virtual Eigen::Vector3d | getFlux (MathLib::Point3d const &, double const, std::vector< std::vector< double > > const &) const |
| Fits to staggered scheme. | |
| Public Member Functions inherited from NumLib::ExtrapolatableElement | |
| virtual | ~ExtrapolatableElement ()=default |
Static Public Attributes | |
| static int const | KelvinVectorSize |
| static constexpr auto & | N_u_op |
Private Types | |
| using | BMatricesType |
| using | IpData |
Private Member Functions | |
| void | assembleWithJacobianForDeformationEquations (const double t, double const dt, Eigen::VectorXd const &local_x, std::vector< double > &local_b_data, std::vector< double > &local_Jac_data) |
| void | assembleWithJacobianForPressureEquations (const double t, double const dt, Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, std::vector< double > &local_b_data, std::vector< double > &local_Jac_data) |
| unsigned | getNumberOfIntegrationPoints () const override |
| int | getMaterialID () const override |
| MaterialLib::Solids::MechanicsBase< DisplacementDim >::MaterialStateVariables const & | getMaterialStateVariablesAt (unsigned integration_point) const override |
Private Attributes | |
| HydroMechanicsProcessData< DisplacementDim > & | _process_data |
| std::vector< IpData, Eigen::aligned_allocator< IpData > > | _ip_data |
| NumLib::GenericIntegrationMethod const & | _integration_method |
| MeshLib::Element const & | _element |
| bool const | _is_axially_symmetric |
| SecondaryData< typename ShapeMatricesTypeDisplacement::ShapeMatrices::ShapeType > | _secondary_data |
Static Private Attributes | |
| static const int | pressure_index = 0 |
| static const int | pressure_size = ShapeFunctionPressure::NPOINTS |
| static const int | displacement_index = ShapeFunctionPressure::NPOINTS |
| static const int | displacement_size |
|
private |
Definition at line 384 of file HydroMechanicsFEM.h.
| using ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::Invariants = MathLib::KelvinVector::Invariants<KelvinVectorSize> |
Definition at line 172 of file HydroMechanicsFEM.h.
|
private |
Definition at line 386 of file HydroMechanicsFEM.h.
| using ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::ShapeMatricesTypeDisplacement |
Definition at line 163 of file HydroMechanicsFEM.h.
| using ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::ShapeMatricesTypePressure |
Definition at line 167 of file HydroMechanicsFEM.h.
| using ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::SymmetricTensor = Eigen::Matrix<double, KelvinVectorSize, 1> |
Definition at line 174 of file HydroMechanicsFEM.h.
|
delete |
References HydroMechanicsLocalAssembler().
Referenced by HydroMechanicsLocalAssembler(), and HydroMechanicsLocalAssembler().
|
delete |
References HydroMechanicsLocalAssembler().
| ProcessLib::HydroMechanics::HydroMechanicsLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::HydroMechanicsLocalAssembler | ( | MeshLib::Element const & | e, |
| std::size_t const | , | ||
| NumLib::GenericIntegrationMethod const & | integration_method, | ||
| bool const | is_axially_symmetric, | ||
| HydroMechanicsProcessData< DisplacementDim > & | process_data ) |
Definition at line 29 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _is_axially_symmetric, _process_data, _secondary_data, MeshLib::Element::getID(), NumLib::initShapeMatrices(), MathLib::KelvinVector::kelvin_vector_dimensions(), and MaterialLib::Solids::selectSolidConstitutiveRelation().
|
inlineoverridevirtual |
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 196 of file HydroMechanicsFEM.h.
References OGS_FATAL.
|
overridevirtual |
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 95 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _is_axially_symmetric, _process_data, MaterialPropertyLib::biot_coefficient, ProcessLib::LinearBMatrix::computeBMatrix(), MathLib::createZeroedMatrix(), MathLib::createZeroedVector(), MaterialPropertyLib::density, displacement_index, displacement_size, MaterialPropertyLib::VariableArray::equivalent_plastic_strain, MaterialPropertyLib::formEigenTensor(), MaterialPropertyLib::VariableArray::gas_phase_pressure, ParameterLib::SpatialPosition::getCoordinates(), MaterialPropertyLib::getFluidDensityAndViscosity(), MathLib::KelvinVector::Invariants< KelvinVectorSize >::identity2, NumLib::interpolateCoordinates(), MathLib::KelvinVector::kelvin_vector_dimensions(), MathLib::KelvinVector::kelvinVectorToSymmetricTensor(), MathLib::KelvinVector::liftVectorToKelvin(), MaterialPropertyLib::VariableArray::liquid_phase_pressure, MaterialPropertyLib::mechanical_strain, MaterialPropertyLib::VariableArray::mechanical_strain, N_u_op, MaterialPropertyLib::permeability, MaterialPropertyLib::porosity, pressure_index, pressure_size, MaterialPropertyLib::reference_temperature, MaterialLib::Solids::selectSolidConstitutiveRelation(), ParameterLib::SpatialPosition::setElementID(), MaterialPropertyLib::VariableArray::temperature, MaterialPropertyLib::VariableArray::total_stress, MathLib::KelvinVector::Invariants< KelvinVectorSize >::trace(), and MaterialPropertyLib::VariableArray::volumetric_strain.
|
private |
Assemble local matrices and vectors arise from the linearized discretized weak form of the residual of the momentum balance equation,
\[ \nabla (\sigma - \alpha_b p \mathrm{I}) = f \]
where \( \sigma\) is the effective stress tensor, \(p\) is the pore pressure, \(\alpha_b\) is the Biot constant, \(\mathrm{I}\) is the identity tensor, and \(f\) is the body force.
| t | Time |
| dt | Time increment |
| local_x | Nodal values of \(x\) of an element of all coupled processes. |
| local_b_data | Right hand side vector of an element. |
| local_Jac_data | Element Jacobian matrix for the Newton-Raphson method. |
Definition at line 641 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _is_axially_symmetric, _process_data, MaterialPropertyLib::biot_coefficient, ProcessLib::LinearBMatrix::computeBMatrix(), MathLib::createZeroedMatrix(), MathLib::createZeroedVector(), MaterialPropertyLib::density, displacement_index, displacement_size, MaterialPropertyLib::VariableArray::gas_phase_pressure, MaterialPropertyLib::getFluidDensity(), NumLib::interpolateCoordinates(), MathLib::KelvinVector::kelvin_vector_dimensions(), MaterialPropertyLib::VariableArray::liquid_phase_pressure, MaterialPropertyLib::VariableArray::mechanical_strain, N_u_op, MaterialPropertyLib::porosity, pressure_index, MaterialPropertyLib::reference_temperature, ParameterLib::SpatialPosition::setElementID(), NumLib::detail::shapeFunctionInterpolate(), and MaterialPropertyLib::VariableArray::temperature.
Referenced by assembleWithJacobianForStaggeredScheme().
|
private |
Assemble local matrices and vectors arise from the linearized discretized weak form of the residual of the mass balance equation of single phase flow,
\[ \alpha \cdot{p} - \nabla (K (\nabla p + \rho g \nabla z) + \alpha_b \nabla \cdot \dot{u} = Q \]
where \( alpha\) is a coefficient may depend on storage or the fluid density change, \( \rho\) is the fluid density, \(g\) is the gravitational acceleration, \(z\) is the vertical coordinate, \(u\) is the displacement, and \(Q\) is the source/sink term.
| t | Time |
| dt | Time increment |
| local_x | Nodal values of \(x\) of an element of all coupled processes. |
| local_x_prev | Nodal values of \(x^{t-1}\) of an element of all coupled processes. |
| local_b_data | Right hand side vector of an element. |
| local_Jac_data | Element Jacobian matrix for the Newton-Raphson method. |
Definition at line 463 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _process_data, MaterialPropertyLib::biot_coefficient, MathLib::createZeroedMatrix(), MathLib::createZeroedVector(), MaterialPropertyLib::density, MaterialPropertyLib::VariableArray::equivalent_plastic_strain, MaterialPropertyLib::formEigenTensor(), MaterialPropertyLib::VariableArray::gas_phase_pressure, MaterialPropertyLib::getFluidDensityAndViscosity(), MathLib::KelvinVector::Invariants< KelvinVectorSize >::identity2, NumLib::interpolateCoordinates(), MathLib::KelvinVector::kelvinVectorToSymmetricTensor(), MaterialPropertyLib::VariableArray::liquid_phase_pressure, MaterialPropertyLib::VariableArray::mechanical_strain, MaterialPropertyLib::permeability, MaterialPropertyLib::porosity, pressure_index, pressure_size, MaterialPropertyLib::reference_temperature, MaterialLib::Solids::selectSolidConstitutiveRelation(), ParameterLib::SpatialPosition::setElementID(), MaterialPropertyLib::VariableArray::temperature, MaterialPropertyLib::VariableArray::total_stress, MathLib::KelvinVector::Invariants< KelvinVectorSize >::trace(), and MaterialPropertyLib::VariableArray::volumetric_strain.
Referenced by assembleWithJacobianForStaggeredScheme().
|
overridevirtual |
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 745 of file HydroMechanicsFEM-impl.h.
References _process_data, assembleWithJacobianForDeformationEquations(), and assembleWithJacobianForPressureEquations().
|
overridevirtual |
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 1108 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _is_axially_symmetric, _process_data, MaterialPropertyLib::biot_coefficient, MaterialPropertyLib::VariableArray::equivalent_plastic_strain, MaterialPropertyLib::VariableArray::gas_phase_pressure, MaterialPropertyLib::getSymmetricTensor(), MathLib::KelvinVector::Invariants< KelvinVectorSize >::identity2, NumLib::interpolateCoordinates(), NumLib::interpolateToHigherOrderNodes(), KelvinVectorSize, MathLib::KelvinVector::kelvinVectorToSymmetricTensor(), MathLib::KelvinVector::kelvinVectorToTensor(), MaterialPropertyLib::VariableArray::liquid_phase_pressure, MaterialPropertyLib::VariableArray::mechanical_strain, MaterialPropertyLib::permeability, pressure_index, MathLib::KelvinVector::tensorToKelvin(), MaterialPropertyLib::VariableArray::total_stress, MathLib::KelvinVector::Invariants< KelvinVectorSize >::trace(), and MaterialPropertyLib::VariableArray::volumetric_strain.
|
overridevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 1064 of file HydroMechanicsFEM-impl.h.
References _integration_method, _ip_data, MathLib::createZeroedMatrix(), getEpsilon(), MathLib::KelvinVector::kelvin_vector_dimensions(), and MathLib::KelvinVector::kelvinVectorToSymmetricTensor().
Referenced by getEpsilon().
|
overridevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 367 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _process_data, MaterialPropertyLib::biot_coefficient, MathLib::createZeroedMatrix(), MaterialPropertyLib::VariableArray::equivalent_plastic_strain, MaterialPropertyLib::formEigenTensor(), MaterialPropertyLib::VariableArray::gas_phase_pressure, MaterialPropertyLib::getFluidDensityAndViscosity(), NumLib::getIndices(), MathLib::KelvinVector::Invariants< KelvinVectorSize >::identity2, NumLib::interpolateCoordinates(), MathLib::KelvinVector::kelvinVectorToSymmetricTensor(), MaterialPropertyLib::VariableArray::liquid_phase_pressure, MaterialPropertyLib::VariableArray::mechanical_strain, MaterialPropertyLib::permeability, pressure_index, pressure_size, MaterialPropertyLib::reference_temperature, ParameterLib::SpatialPosition::setElementID(), MaterialPropertyLib::VariableArray::temperature, MaterialPropertyLib::VariableArray::total_stress, MathLib::KelvinVector::Invariants< KelvinVectorSize >::trace(), and MaterialPropertyLib::VariableArray::volumetric_strain.
|
inlineoverridevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 307 of file HydroMechanicsFEM.h.
References _ip_data, ProcessLib::HydroMechanics::IntegrationPointData< BMatricesType, ShapeMatricesTypeDisplacement, ShapeMatricesTypePressure, DisplacementDim, ShapeFunctionDisplacement::NPOINTS >::eps, and ProcessLib::getIntegrationPointKelvinVectorData().
|
inlineoverridevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 297 of file HydroMechanicsFEM.h.
References _ip_data, ProcessLib::getIntegrationPointKelvinVectorData(), and ProcessLib::HydroMechanics::IntegrationPointData< BMatricesType, ShapeMatricesTypeDisplacement, ShapeMatricesTypePressure, DisplacementDim, ShapeFunctionDisplacement::NPOINTS >::sigma_eff.
|
overrideprivatevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 1213 of file HydroMechanicsFEM-impl.h.
References _element, _process_data, and getMaterialID().
Referenced by getMaterialID().
|
overrideprivatevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 1225 of file HydroMechanicsFEM-impl.h.
References _ip_data.
|
overrideprivatevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 1204 of file HydroMechanicsFEM-impl.h.
References _integration_method, and getNumberOfIntegrationPoints().
Referenced by getNumberOfIntegrationPoints().
|
inlineoverridevirtual |
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 317 of file HydroMechanicsFEM.h.
References displacement_size.
|
inlineoverridevirtual |
Provides the shape matrix at the given integration point.
Implements NumLib::ExtrapolatableElement.
Definition at line 273 of file HydroMechanicsFEM.h.
References _secondary_data.
|
overridevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 1054 of file HydroMechanicsFEM-impl.h.
References _ip_data, ProcessLib::getIntegrationPointKelvinVectorData(), getSigma(), and ProcessLib::HydroMechanics::IntegrationPointData< BMatricesType, ShapeMatricesTypeDisplacement, ShapeMatricesTypePressure, DisplacementDim, ShapeFunctionDisplacement::NPOINTS >::sigma_eff.
Referenced by getSigma().
|
overridevirtual |
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 1090 of file HydroMechanicsFEM-impl.h.
References _integration_method, _ip_data, and getStrainRateVariable().
Referenced by getStrainRateVariable().
|
inlineoverridevirtual |
Set initial stress from parameter.
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 220 of file HydroMechanicsFEM.h.
References _element, _integration_method, _ip_data, _process_data, NumLib::interpolateCoordinates(), and MathLib::KelvinVector::symmetricTensorToKelvinVector().
|
overridevirtual |
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 831 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _is_axially_symmetric, _process_data, ProcessLib::LinearBMatrix::computeBMatrix(), displacement_index, MaterialPropertyLib::EmptyVariableArray, ParameterLib::SpatialPosition::getCoordinates(), NumLib::interpolateCoordinates(), MaterialPropertyLib::VariableArray::mechanical_strain, pressure_index, MaterialPropertyLib::reference_temperature, ParameterLib::SpatialPosition::setElementID(), and MaterialPropertyLib::VariableArray::temperature.
|
overridevirtual |
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 919 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _process_data, MaterialPropertyLib::biot_coefficient, NumLib::interpolateCoordinates(), postTimestepConcrete(), pressure_index, MaterialPropertyLib::reference_temperature, MaterialLib::Solids::selectSolidConstitutiveRelation(), ParameterLib::SpatialPosition::setElementID(), MaterialPropertyLib::VariableArray::temperature, and MathLib::KelvinVector::Invariants< KelvinVectorSize >::trace().
Referenced by postTimestepConcrete().
|
overridevirtual |
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 769 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _is_axially_symmetric, _process_data, MaterialPropertyLib::biot_coefficient, ProcessLib::LinearBMatrix::computeBMatrix(), displacement_index, ParameterLib::SpatialPosition::getCoordinates(), MathLib::KelvinVector::Invariants< KelvinVectorSize >::identity2, NumLib::interpolateCoordinates(), MaterialPropertyLib::VariableArray::mechanical_strain, pressure_index, and ParameterLib::SpatialPosition::setElementID().
|
overridevirtual |
Returns number of read integration points.
Implements ProcessLib::HydroMechanics::LocalAssemblerInterface< DisplacementDim >.
Definition at line 1006 of file HydroMechanicsFEM-impl.h.
References _element, _integration_method, _ip_data, _process_data, ProcessLib::HydroMechanics::IntegrationPointData< BMatricesType, ShapeMatricesTypeDisplacement, ShapeMatricesTypePressure, DisplacementDim, ShapeFunctionDisplacement::NPOINTS >::eps, OGS_FATAL, ProcessLib::setIntegrationPointKelvinVectorData(), ProcessLib::setIntegrationPointScalarData(), ProcessLib::HydroMechanics::IntegrationPointData< BMatricesType, ShapeMatricesTypeDisplacement, ShapeMatricesTypePressure, DisplacementDim, ShapeFunctionDisplacement::NPOINTS >::sigma_eff, and ProcessLib::HydroMechanics::IntegrationPointData< BMatricesType, ShapeMatricesTypeDisplacement, ShapeMatricesTypePressure, DisplacementDim, ShapeFunctionDisplacement::NPOINTS >::strain_rate_variable.
|
private |
Definition at line 393 of file HydroMechanicsFEM.h.
Referenced by HydroMechanicsLocalAssembler(), assembleWithJacobian(), assembleWithJacobianForDeformationEquations(), assembleWithJacobianForPressureEquations(), computeSecondaryVariableConcrete(), getIntPtDarcyVelocity(), getMaterialID(), initializeConcrete(), postNonLinearSolverConcrete(), postTimestepConcrete(), setInitialConditionsConcrete(), and setIPDataInitialConditions().
|
private |
Definition at line 392 of file HydroMechanicsFEM.h.
Referenced by HydroMechanicsLocalAssembler(), assembleWithJacobian(), assembleWithJacobianForDeformationEquations(), assembleWithJacobianForPressureEquations(), computeSecondaryVariableConcrete(), getEpsilon(), getIntPtDarcyVelocity(), getNumberOfIntegrationPoints(), getStrainRateVariable(), initializeConcrete(), postNonLinearSolverConcrete(), postTimestepConcrete(), setInitialConditionsConcrete(), and setIPDataInitialConditions().
|
private |
Definition at line 390 of file HydroMechanicsFEM.h.
Referenced by HydroMechanicsLocalAssembler(), assembleWithJacobian(), assembleWithJacobianForDeformationEquations(), assembleWithJacobianForPressureEquations(), computeSecondaryVariableConcrete(), getEpsilon(), getIntPtDarcyVelocity(), getIntPtEpsilon(), getIntPtSigma(), getMaterialStateVariablesAt(), getSigma(), getStrainRateVariable(), initializeConcrete(), postNonLinearSolverConcrete(), postTimestepConcrete(), setInitialConditionsConcrete(), and setIPDataInitialConditions().
|
private |
Definition at line 394 of file HydroMechanicsFEM.h.
Referenced by HydroMechanicsLocalAssembler(), assembleWithJacobian(), assembleWithJacobianForDeformationEquations(), computeSecondaryVariableConcrete(), postNonLinearSolverConcrete(), and setInitialConditionsConcrete().
|
private |
Definition at line 382 of file HydroMechanicsFEM.h.
Referenced by HydroMechanicsLocalAssembler(), assembleWithJacobian(), assembleWithJacobianForDeformationEquations(), assembleWithJacobianForPressureEquations(), assembleWithJacobianForStaggeredScheme(), computeSecondaryVariableConcrete(), getIntPtDarcyVelocity(), getMaterialID(), initializeConcrete(), postNonLinearSolverConcrete(), postTimestepConcrete(), setInitialConditionsConcrete(), and setIPDataInitialConditions().
|
private |
Definition at line 397 of file HydroMechanicsFEM.h.
Referenced by HydroMechanicsLocalAssembler(), and getShapeMatrix().
|
staticprivate |
Definition at line 401 of file HydroMechanicsFEM.h.
Referenced by assembleWithJacobian(), assembleWithJacobianForDeformationEquations(), postNonLinearSolverConcrete(), and setInitialConditionsConcrete().
|
staticprivate |
Definition at line 402 of file HydroMechanicsFEM.h.
Referenced by assembleWithJacobian(), assembleWithJacobianForDeformationEquations(), and getNumberOfVectorElementsForDeformation().
|
static |
Definition at line 170 of file HydroMechanicsFEM.h.
Referenced by computeSecondaryVariableConcrete().
|
staticconstexpr |
Definition at line 176 of file HydroMechanicsFEM.h.
Referenced by assembleWithJacobian(), and assembleWithJacobianForDeformationEquations().
|
staticprivate |
Definition at line 399 of file HydroMechanicsFEM.h.
Referenced by assembleWithJacobian(), assembleWithJacobianForDeformationEquations(), assembleWithJacobianForPressureEquations(), computeSecondaryVariableConcrete(), getIntPtDarcyVelocity(), postNonLinearSolverConcrete(), postTimestepConcrete(), and setInitialConditionsConcrete().
|
staticprivate |
Definition at line 400 of file HydroMechanicsFEM.h.
Referenced by assembleWithJacobian(), assembleWithJacobianForPressureEquations(), and getIntPtDarcyVelocity().