OGS
ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim > Class Template Reference

Detailed Description

template<typename ShapeFunctionDisplacement, typename ShapeFunctionPressure, int DisplacementDim>
class ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >

Definition at line 48 of file TH2MFEM.h.

#include <TH2MFEM.h>

Inheritance diagram for ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >:
[legend]
Collaboration diagram for ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >:
[legend]

Public Types

using ShapeMatricesTypeDisplacement
 
using ShapeMatricesTypePressure
 
template<int N>
using VectorType
 
template<int M, int N>
using MatrixType
 
using GlobalDimMatrixType
 
using GlobalDimVectorType
 
using SymmetricTensor = Eigen::Matrix<double, KelvinVectorSize, 1>
 
using Invariants = MathLib::KelvinVector::Invariants<KelvinVectorSize>
 

Public Member Functions

 TH2MLocalAssembler (TH2MLocalAssembler const &)=delete
 
 TH2MLocalAssembler (TH2MLocalAssembler &&)=delete
 
 TH2MLocalAssembler (MeshLib::Element const &e, std::size_t const, NumLib::GenericIntegrationMethod const &integration_method, bool const is_axially_symmetric, TH2MProcessData< DisplacementDim > &process_data)
 
- Public Member Functions inherited from ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >
 LocalAssemblerInterface (MeshLib::Element const &e, NumLib::GenericIntegrationMethod const &integration_method, bool const is_axially_symmetric, TH2MProcessData< DisplacementDim > &process_data)
 
unsigned getNumberOfIntegrationPoints () const
 
int getMaterialID () const
 
std::vector< double > getMaterialStateVariableInternalState (std::function< std::span< double >(typename ConstitutiveRelations::SolidConstitutiveRelation< DisplacementDim >::MaterialStateVariables &)> const &get_values_span, int const &n_components) const
 
ConstitutiveRelations::SolidConstitutiveRelation< DisplacementDim >::MaterialStateVariables const & getMaterialStateVariablesAt (unsigned integration_point) const
 
- 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 assembleWithJacobianForStaggeredScheme (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_b_data, std::vector< double > &local_Jac_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

std::size_t setIPDataInitialConditions (std::string_view const name, double const *values, int const integration_order) override
 
void setInitialConditionsConcrete (Eigen::VectorXd const local_x, double const t, int const process_id) override
 
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 initializeConcrete () override
 
void postTimestepConcrete (Eigen::VectorXd const &, Eigen::VectorXd const &, double const, double const, int const) override
 
void computeSecondaryVariableConcrete (double const t, double const dt, Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev) override
 
Eigen::Map< const Eigen::RowVectorXd > getShapeMatrix (const unsigned integration_point) const override
 Provides the shape matrix at the given integration point.
 
std::tuple< std::vector< ConstitutiveRelations::ConstitutiveData< DisplacementDim > >, std::vector< ConstitutiveRelations::ConstitutiveTempData< DisplacementDim > > > updateConstitutiveVariables (Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, double const t, double const dt, ConstitutiveRelations::ConstitutiveModels< DisplacementDim > const &models)
 
std::vector< ConstitutiveRelations::DerivativesData< DisplacementDim > > updateConstitutiveVariablesDerivatives (Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, double const t, double const dt, std::vector< ConstitutiveRelations::ConstitutiveData< DisplacementDim > > const &ip_constitutive_data, std::vector< ConstitutiveRelations::ConstitutiveTempData< DisplacementDim > > const &ip_constitutive_variables, ConstitutiveRelations::ConstitutiveModels< DisplacementDim > const &models)
 
virtual std::optional< VectorSegmentgetVectorDeformationSegment () const override
 

Private Attributes

std::vector< IpData_ip_data
 
SecondaryData< typename ShapeMatricesTypeDisplacement::ShapeMatrices::ShapeType > _secondary_data
 

Static Private Attributes

static const int gas_pressure_index = 0
 
static const int gas_pressure_size = ShapeFunctionPressure::NPOINTS
 
static const int capillary_pressure_index = ShapeFunctionPressure::NPOINTS
 
static const int capillary_pressure_size = ShapeFunctionPressure::NPOINTS
 
static const int temperature_index = 2 * ShapeFunctionPressure::NPOINTS
 
static const int temperature_size = ShapeFunctionPressure::NPOINTS
 
static const int displacement_index = ShapeFunctionPressure::NPOINTS * 3
 
static const int displacement_size
 
static const int C_index = 0
 
static const int C_size = ShapeFunctionPressure::NPOINTS
 
static const int W_index = ShapeFunctionPressure::NPOINTS
 
static const int W_size = ShapeFunctionPressure::NPOINTS
 

Additional Inherited Members

- Static Public Member Functions inherited from ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >
static auto getReflectionDataForOutput ()
 
- Public Attributes inherited from ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >
TH2MProcessData< DisplacementDim > & process_data_
 
std::vector< typename ConstitutiveRelations::StatefulData< DisplacementDim > > current_states_
 
std::vector< typename ConstitutiveRelations::StatefulDataPrev< DisplacementDim > > prev_states_
 
std::vector< ConstitutiveRelations::MaterialStateData< DisplacementDim > > material_states_
 
std::vector< ConstitutiveRelations::OutputData< DisplacementDim > > output_data_
 
NumLib::GenericIntegrationMethod const & integration_method_
 
MeshLib::Element const & element_
 
bool const is_axially_symmetric_
 
ConstitutiveRelations::SolidConstitutiveRelation< DisplacementDim > const & solid_material_
 

Member Typedef Documentation

◆ BMatricesType

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::BMatricesType
private
Initial value:
BMatrixPolicyType<ShapeFunctionDisplacement, DisplacementDim>

Definition at line 220 of file TH2MFEM.h.

◆ GlobalDimMatrixType

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::GlobalDimMatrixType
Initial value:

Definition at line 65 of file TH2MFEM.h.

◆ GlobalDimVectorType

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::GlobalDimVectorType
Initial value:

Definition at line 68 of file TH2MFEM.h.

◆ Invariants

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::Invariants = MathLib::KelvinVector::Invariants<KelvinVectorSize>

Definition at line 79 of file TH2MFEM.h.

◆ IpData

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::IpData
private
Initial value:
IntegrationPointData<ShapeMatricesTypeDisplacement,
ShapeMatrixPolicyType< ShapeFunctionDisplacement, DisplacementDim > ShapeMatricesTypeDisplacement
Definition TH2MFEM.h:51
ShapeMatrixPolicyType< ShapeFunctionPressure, DisplacementDim > ShapeMatricesTypePressure
Definition TH2MFEM.h:54

Definition at line 222 of file TH2MFEM.h.

◆ MatrixType

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
template<int M, int N>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::MatrixType
Initial value:
typename ShapeMatricesTypePressure::template MatrixType<M, N>
typename ShapeMatricesTypePressure::template MatrixType< M, N > MatrixType
Definition TH2MFEM.h:62

Definition at line 62 of file TH2MFEM.h.

◆ ShapeMatricesTypeDisplacement

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::ShapeMatricesTypeDisplacement

◆ ShapeMatricesTypePressure

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::ShapeMatricesTypePressure

◆ SymmetricTensor

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::SymmetricTensor = Eigen::Matrix<double, KelvinVectorSize, 1>

Definition at line 73 of file TH2MFEM.h.

◆ VectorType

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
template<int N>
using ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::VectorType
Initial value:
typename ShapeMatricesTypePressure::template VectorType<N>
typename ShapeMatricesTypePressure::template VectorType< N > VectorType
Definition TH2MFEM.h:58

Definition at line 58 of file TH2MFEM.h.

Constructor & Destructor Documentation

◆ TH2MLocalAssembler() [1/3]

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::TH2MLocalAssembler ( TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim > const & )
delete

◆ TH2MLocalAssembler() [2/3]

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::TH2MLocalAssembler ( TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim > && )
delete

◆ TH2MLocalAssembler() [3/3]

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::TH2MLocalAssembler ( MeshLib::Element const & e,
std::size_t const ,
NumLib::GenericIntegrationMethod const & integration_method,
bool const is_axially_symmetric,
TH2MProcessData< DisplacementDim > & process_data )

Definition at line 36 of file TH2MFEM-impl.h.

44 e, integration_method, is_axially_symmetric, process_data)
45{
46 unsigned const n_integration_points =
48
49 _ip_data.resize(n_integration_points);
50 _secondary_data.N_u.resize(n_integration_points);
51
52 auto const shape_matrices_u =
53 NumLib::initShapeMatrices<ShapeFunctionDisplacement,
55 DisplacementDim>(e, is_axially_symmetric,
57
58 auto const shape_matrices_p =
59 NumLib::initShapeMatrices<ShapeFunctionPressure,
60 ShapeMatricesTypePressure, DisplacementDim>(
61 e, is_axially_symmetric, this->integration_method_);
62
63 for (unsigned ip = 0; ip < n_integration_points; ip++)
64 {
65 auto& ip_data = _ip_data[ip];
66 auto const& sm_u = shape_matrices_u[ip];
67 ip_data.integration_weight =
69 sm_u.integralMeasure * sm_u.detJ;
70
71 ip_data.N_u = sm_u.N;
72 ip_data.dNdx_u = sm_u.dNdx;
73
74 ip_data.N_p = shape_matrices_p[ip].N;
75 ip_data.dNdx_p = shape_matrices_p[ip].dNdx;
76
77 _secondary_data.N_u[ip] = shape_matrices_u[ip].N;
78 }
79}
constexpr double getWeight() const
MathLib::WeightedPoint const & getWeightedPoint(unsigned const igp) const
SecondaryData< typename ShapeMatricesTypeDisplacement::ShapeMatrices::ShapeType > _secondary_data
Definition TH2MFEM.h:228
std::vector< IpData > _ip_data
Definition TH2MFEM.h:224
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)
NumLib::GenericIntegrationMethod const & integration_method_
LocalAssemblerInterface(MeshLib::Element const &e, NumLib::GenericIntegrationMethod const &integration_method, bool const is_axially_symmetric, TH2MProcessData< DisplacementDim > &process_data)
std::vector< ShapeMatrixType, Eigen::aligned_allocator< ShapeMatrixType > > N_u
Definition TH2MFEM.h:43

References ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::_ip_data, ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::_secondary_data, NumLib::GenericIntegrationMethod::getNumberOfPoints(), MathLib::WeightedPoint::getWeight(), NumLib::GenericIntegrationMethod::getWeightedPoint(), NumLib::initShapeMatrices(), ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::integration_method_, and ProcessLib::TH2M::SecondaryData< ShapeMatrixType >::N_u.

Member Function Documentation

◆ assemble()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
void ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::assemble ( double const t,
double const dt,
std::vector< double > const & local_x,
std::vector< double > const & local_x_prev,
std::vector< double > & local_M_data,
std::vector< double > & local_K_data,
std::vector< double > & local_rhs_data )
overrideprivatevirtual

Reimplemented from ProcessLib::LocalAssemblerInterface.

Definition at line 931 of file TH2MFEM-impl.h.

937{
938 auto const matrix_size = gas_pressure_size + capillary_pressure_size +
940 assert(local_x.size() == matrix_size);
941
942 auto const capillary_pressure =
943 Eigen::Map<VectorType<capillary_pressure_size> const>(
945
946 auto const capillary_pressure_prev =
947 Eigen::Map<VectorType<capillary_pressure_size> const>(
948 local_x_prev.data() + capillary_pressure_index,
950
951 // pointer to local_M_data vector
952 auto local_M =
954 local_M_data, matrix_size, matrix_size);
955
956 // pointer to local_K_data vector
957 auto local_K =
959 local_K_data, matrix_size, matrix_size);
960
961 // pointer to local_rhs_data vector
963 local_rhs_data, matrix_size);
964
965 // component-formulation
966 // W - liquid phase main component
967 // C - gas phase main component
968 // pointer-matrices to the mass matrix - C component equation
969 auto MCpG = local_M.template block<C_size, gas_pressure_size>(
971 auto MCpC = local_M.template block<C_size, capillary_pressure_size>(
973 auto MCT = local_M.template block<C_size, temperature_size>(
975 auto MCu = local_M.template block<C_size, displacement_size>(
977
978 // pointer-matrices to the stiffness matrix - C component equation
979 auto LCpG = local_K.template block<C_size, gas_pressure_size>(
981 auto LCpC = local_K.template block<C_size, capillary_pressure_size>(
983 auto LCT = local_K.template block<C_size, temperature_size>(
985
986 // pointer-matrices to the mass matrix - W component equation
987 auto MWpG = local_M.template block<W_size, gas_pressure_size>(
989 auto MWpC = local_M.template block<W_size, capillary_pressure_size>(
991 auto MWT = local_M.template block<W_size, temperature_size>(
993 auto MWu = local_M.template block<W_size, displacement_size>(
995
996 // pointer-matrices to the stiffness matrix - W component equation
997 auto LWpG = local_K.template block<W_size, gas_pressure_size>(
999 auto LWpC = local_K.template block<W_size, capillary_pressure_size>(
1001 auto LWT = local_K.template block<W_size, temperature_size>(
1003
1004 // pointer-matrices to the mass matrix - temperature equation
1005 auto MTu = local_M.template block<temperature_size, displacement_size>(
1007
1008 // pointer-matrices to the stiffness matrix - temperature equation
1009 auto KTT = local_K.template block<temperature_size, temperature_size>(
1011
1012 // pointer-matrices to the stiffness matrix - displacement equation
1013 auto KUpG = local_K.template block<displacement_size, gas_pressure_size>(
1015 auto KUpC =
1016 local_K.template block<displacement_size, capillary_pressure_size>(
1018
1019 auto KUU = local_K.template block<displacement_size, displacement_size>(
1021
1022 // pointer-vectors to the right hand side terms - C-component equation
1023 auto fC = local_f.template segment<C_size>(C_index);
1024 // pointer-vectors to the right hand side terms - W-component equation
1025 auto fW = local_f.template segment<W_size>(W_index);
1026 // pointer-vectors to the right hand side terms - temperature equation
1027 auto fT = local_f.template segment<temperature_size>(temperature_index);
1028 // pointer-vectors to the right hand side terms - displacement equation
1029 auto fU = local_f.template segment<displacement_size>(displacement_index);
1030
1031 unsigned const n_integration_points =
1033
1034 ConstitutiveRelations::ConstitutiveModels<DisplacementDim> const models{
1035 this->solid_material_, *this->process_data_.phase_transition_model_};
1036
1037 auto const [ip_constitutive_data, ip_constitutive_variables] =
1039 Eigen::Map<Eigen::VectorXd const>(local_x.data(), local_x.size()),
1040 Eigen::Map<Eigen::VectorXd const>(local_x_prev.data(),
1041 local_x_prev.size()),
1042 t, dt, models);
1043
1044 for (unsigned int_point = 0; int_point < n_integration_points; int_point++)
1045 {
1046 auto& ip = _ip_data[int_point];
1047 auto& ip_cv = ip_constitutive_variables[int_point];
1048 auto& ip_cd = ip_constitutive_data[int_point];
1049
1050 auto& ip_out = this->output_data_[int_point];
1051 auto& current_state = this->current_states_[int_point];
1052 auto const& prev_state = this->prev_states_[int_point];
1053
1054 auto const& Np = ip.N_p;
1055 auto const& NT = Np;
1056 auto const& Nu = ip.N_u;
1058 std::nullopt, this->element_.getID(),
1060 NumLib::interpolateCoordinates<ShapeFunctionDisplacement,
1062 this->element_, Nu))};
1063
1064 auto const& NpT = Np.transpose().eval();
1065 auto const& NTT = NT.transpose().eval();
1066
1067 auto const& gradNp = ip.dNdx_p;
1068 auto const& gradNT = gradNp;
1069 auto const& gradNu = ip.dNdx_u;
1070
1071 auto const& gradNpT = gradNp.transpose().eval();
1072 auto const& gradNTT = gradNT.transpose().eval();
1073
1074 auto const& w = ip.integration_weight;
1075
1076 auto const x_coord =
1077 NumLib::interpolateXCoordinate<ShapeFunctionDisplacement,
1079 this->element_, Nu);
1080
1081 auto const Bu =
1082 LinearBMatrix::computeBMatrix<DisplacementDim,
1083 ShapeFunctionDisplacement::NPOINTS,
1085 gradNu, Nu, x_coord, this->is_axially_symmetric_);
1086
1087 auto const NTN = (Np.transpose() * Np).eval();
1088 auto const BTI2N = (Bu.transpose() * Invariants::identity2 * Np).eval();
1089
1090 double const pCap = Np.dot(capillary_pressure);
1091 double const pCap_prev = Np.dot(capillary_pressure_prev);
1092
1093 auto const s_L = current_state.S_L_data.S_L;
1094 auto const s_L_dot = (s_L - prev_state.S_L_data->S_L) / dt;
1095
1096 auto const& b = this->process_data_.specific_body_force;
1097
1098 // ---------------------------------------------------------------------
1099 // C-component equation
1100 // ---------------------------------------------------------------------
1101
1102 MCpG.noalias() += NTN * (ip_cv.fC_4_MCpG.m * w);
1103 MCpC.noalias() += NTN * (ip_cv.fC_4_MCpC.m * w);
1104
1105 if (this->process_data_.apply_mass_lumping)
1106 {
1107 if (pCap - pCap_prev != 0.) // avoid division by Zero
1108 {
1109 MCpC.noalias() +=
1110 NTN * (ip_cv.fC_4_MCpC.ml / (pCap - pCap_prev) * w);
1111 }
1112 }
1113
1114 MCT.noalias() += NTN * (ip_cv.fC_4_MCT.m * w);
1115 MCu.noalias() += BTI2N.transpose() * (ip_cv.fC_4_MCu.m * w);
1116
1117 LCpG.noalias() += gradNpT * ip_cv.fC_4_LCpG.L * gradNp * w;
1118
1119 LCpC.noalias() += gradNpT * ip_cv.fC_4_LCpC.L * gradNp * w;
1120
1121 LCT.noalias() += gradNpT * ip_cv.fC_4_LCT.L * gradNp * w;
1122
1123 fC.noalias() += gradNpT * ip_cv.fC_1.A * b * w;
1124
1125 if (!this->process_data_.apply_mass_lumping)
1126 {
1127 fC.noalias() -= NpT * (ip_cv.fC_2a.a * s_L_dot * w);
1128 }
1129 // fC_III
1130 fC.noalias() -= NpT * (ip_out.porosity_data.phi * ip_cv.fC_3a.a * w);
1131
1132 // ---------------------------------------------------------------------
1133 // W-component equation
1134 // ---------------------------------------------------------------------
1135
1136 MWpG.noalias() += NTN * (ip_cv.fW_4_MWpG.m * w);
1137 MWpC.noalias() += NTN * (ip_cv.fW_4_MWpC.m * w);
1138
1139 if (this->process_data_.apply_mass_lumping)
1140 {
1141 if (pCap - pCap_prev != 0.) // avoid division by Zero
1142 {
1143 MWpC.noalias() +=
1144 NTN * (ip_cv.fW_4_MWpC.ml / (pCap - pCap_prev) * w);
1145 }
1146 }
1147
1148 MWT.noalias() += NTN * (ip_cv.fW_4_MWT.m * w);
1149
1150 MWu.noalias() += BTI2N.transpose() * (ip_cv.fW_4_MWu.m * w);
1151
1152 LWpG.noalias() += gradNpT * ip_cv.fW_4_LWpG.L * gradNp * w;
1153
1154 LWpC.noalias() += gradNpT * ip_cv.fW_4_LWpC.L * gradNp * w;
1155
1156 LWT.noalias() += gradNpT * ip_cv.fW_4_LWT.L * gradNp * w;
1157
1158 fW.noalias() += gradNpT * ip_cv.fW_1.A * b * w;
1159
1160 if (!this->process_data_.apply_mass_lumping)
1161 {
1162 fW.noalias() -= NpT * (ip_cv.fW_2.a * s_L_dot * w);
1163 }
1164
1165 fW.noalias() -= NpT * (ip_out.porosity_data.phi * ip_cv.fW_3a.a * w);
1166
1167 // ---------------------------------------------------------------------
1168 // - temperature equation
1169 // ---------------------------------------------------------------------
1170
1171 MTu.noalias() +=
1172 BTI2N.transpose() *
1173 (ip_cv.effective_volumetric_enthalpy_data.rho_h_eff * w);
1174
1175 KTT.noalias() +=
1176 gradNTT * ip_cv.thermal_conductivity_data.lambda * gradNT * w;
1177
1178 fT.noalias() -= NTT * (ip_cv.fT_1.m * w);
1179
1180 fT.noalias() += gradNTT * ip_cv.fT_2.A * w;
1181
1182 fT.noalias() += gradNTT * ip_cv.fT_3.gradN * w;
1183
1184 fT.noalias() += NTT * (ip_cv.fT_3.N * w);
1185
1186 // ---------------------------------------------------------------------
1187 // - displacement equation
1188 // ---------------------------------------------------------------------
1189
1190 KUpG.noalias() -= BTI2N * (ip_cv.biot_data() * w);
1191
1192 KUpC.noalias() += BTI2N * (ip_cv.fu_2_KupC.m * w);
1193
1194 KUU.noalias() +=
1195 Bu.transpose() * ip_cd.s_mech_data.stiffness_tensor * Bu * w;
1196
1197 fU.noalias() -=
1198 (Bu.transpose() * current_state.eff_stress_data.sigma -
1199 N_u_op(Nu).transpose() * ip_cv.volumetric_body_force()) *
1200 w;
1201
1202 if (this->process_data_.apply_mass_lumping)
1203 {
1204 MCpG = MCpG.colwise().sum().eval().asDiagonal();
1205 MCpC = MCpC.colwise().sum().eval().asDiagonal();
1206 MWpG = MWpG.colwise().sum().eval().asDiagonal();
1207 MWpC = MWpC.colwise().sum().eval().asDiagonal();
1208 }
1209 } // int_point-loop
1210}
std::size_t getID() const
Returns the ID of the element.
Definition Element.h:89
MatrixType< _kelvin_vector_size, _number_of_dof > BMatrixType
static constexpr auto & N_u_op
Definition TH2MFEM.h:75
static const int capillary_pressure_index
Definition TH2MFEM.h:234
static const int capillary_pressure_size
Definition TH2MFEM.h:235
static const int gas_pressure_index
Definition TH2MFEM.h:232
std::tuple< std::vector< ConstitutiveRelations::ConstitutiveData< DisplacementDim > >, std::vector< ConstitutiveRelations::ConstitutiveTempData< DisplacementDim > > > updateConstitutiveVariables(Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, double const t, double const dt, ConstitutiveRelations::ConstitutiveModels< DisplacementDim > const &models)
static const int displacement_index
Definition TH2MFEM.h:238
Eigen::Map< Vector > createZeroedVector(std::vector< double > &data, Eigen::VectorXd::Index size)
Eigen::Map< Matrix > createZeroedMatrix(std::vector< double > &data, Eigen::MatrixXd::Index rows, Eigen::MatrixXd::Index cols)
double interpolateXCoordinate(MeshLib::Element const &e, typename ShapeMatricesType::ShapeMatrices::ShapeType const &N)
std::array< double, 3 > interpolateCoordinates(MeshLib::Element const &e, typename ShapeMatricesType::ShapeMatrices::ShapeType const &N)
auto eval(Function &f, Tuples &... ts) -> typename detail::GetFunctionReturnType< decltype(&Function::eval)>::type
Definition Apply.h:274
BMatrixType computeBMatrix(DNDX_Type const &dNdx, N_Type const &N, const double radius, const bool is_axially_symmetric)
Fills a B-matrix based on given shape function dN/dx values.
static Eigen::Matrix< double, KelvinVectorSize, 1 > const identity2
Kelvin mapping of 2nd order identity tensor.
TH2MProcessData< DisplacementDim > & process_data_
ConstitutiveRelations::SolidConstitutiveRelation< DisplacementDim > const & solid_material_
std::vector< typename ConstitutiveRelations::StatefulData< DisplacementDim > > current_states_
std::vector< typename ConstitutiveRelations::StatefulDataPrev< DisplacementDim > > prev_states_
std::vector< ConstitutiveRelations::OutputData< DisplacementDim > > output_data_

References MathLib::createZeroedMatrix(), MathLib::createZeroedVector(), NumLib::interpolateCoordinates(), and NumLib::interpolateXCoordinate().

◆ assembleWithJacobian()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
void ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::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 )
overrideprivatevirtual

Reimplemented from ProcessLib::LocalAssemblerInterface.

Definition at line 1217 of file TH2MFEM-impl.h.

1223{
1224 auto const matrix_size = gas_pressure_size + capillary_pressure_size +
1226 assert(local_x.size() == matrix_size);
1227
1228 auto const temperature = Eigen::Map<VectorType<temperature_size> const>(
1229 local_x.data() + temperature_index, temperature_size);
1230
1231 auto const gas_pressure = Eigen::Map<VectorType<gas_pressure_size> const>(
1232 local_x.data() + gas_pressure_index, gas_pressure_size);
1233
1234 auto const capillary_pressure =
1235 Eigen::Map<VectorType<capillary_pressure_size> const>(
1237
1238 auto const displacement = Eigen::Map<VectorType<displacement_size> const>(
1239 local_x.data() + displacement_index, displacement_size);
1240
1241 auto const gas_pressure_prev =
1242 Eigen::Map<VectorType<gas_pressure_size> const>(
1243 local_x_prev.data() + gas_pressure_index, gas_pressure_size);
1244
1245 auto const capillary_pressure_prev =
1246 Eigen::Map<VectorType<capillary_pressure_size> const>(
1247 local_x_prev.data() + capillary_pressure_index,
1249
1250 auto const temperature_prev =
1251 Eigen::Map<VectorType<temperature_size> const>(
1252 local_x_prev.data() + temperature_index, temperature_size);
1253
1254 auto const displacement_prev =
1255 Eigen::Map<VectorType<displacement_size> const>(
1256 local_x_prev.data() + displacement_index, displacement_size);
1257
1258 auto local_Jac =
1260 local_Jac_data, matrix_size, matrix_size);
1261
1263 local_rhs_data, matrix_size);
1264
1265 // component-formulation
1266 // W - liquid phase main component
1267 // C - gas phase main component
1268
1269 // C component equation matrices
1271 MatrixType<C_size, gas_pressure_size>::Zero(C_size, gas_pressure_size);
1273 MatrixType<C_size, capillary_pressure_size>::Zero(
1276 MatrixType<C_size, temperature_size>::Zero(C_size, temperature_size);
1278 MatrixType<C_size, displacement_size>::Zero(C_size, displacement_size);
1279
1281 MatrixType<C_size, gas_pressure_size>::Zero(C_size, gas_pressure_size);
1283 MatrixType<C_size, capillary_pressure_size>::Zero(
1286 MatrixType<C_size, temperature_size>::Zero(C_size, temperature_size);
1287
1288 // mass matrix - W component equation
1290 MatrixType<W_size, gas_pressure_size>::Zero(W_size, gas_pressure_size);
1292 MatrixType<W_size, capillary_pressure_size>::Zero(
1295 MatrixType<W_size, temperature_size>::Zero(W_size, temperature_size);
1297 MatrixType<W_size, displacement_size>::Zero(W_size, displacement_size);
1298
1299 // stiffness matrix - W component equation
1301 MatrixType<W_size, gas_pressure_size>::Zero(W_size, gas_pressure_size);
1303 MatrixType<W_size, capillary_pressure_size>::Zero(
1306 MatrixType<W_size, temperature_size>::Zero(W_size, temperature_size);
1307
1308 // mass matrix - temperature equation
1310 MatrixType<temperature_size, displacement_size>::Zero(
1312
1313 // stiffness matrix - temperature equation
1315 MatrixType<temperature_size, temperature_size>::Zero(temperature_size,
1317
1318 // stiffness matrices - displacement equation coupling into pressures
1320 MatrixType<displacement_size, gas_pressure_size>::Zero(
1323 MatrixType<displacement_size, capillary_pressure_size>::Zero(
1325
1326 // pointer-vectors to the right hand side terms - C-component equation
1327 auto fC = local_f.template segment<C_size>(C_index);
1328 // pointer-vectors to the right hand side terms - W-component equation
1329 auto fW = local_f.template segment<W_size>(W_index);
1330 // pointer-vectors to the right hand side terms - temperature equation
1331 auto fT = local_f.template segment<temperature_size>(temperature_index);
1332 // pointer-vectors to the right hand side terms - displacement equation
1333 auto fU = local_f.template segment<displacement_size>(displacement_index);
1334
1335 unsigned const n_integration_points =
1337
1338 ConstitutiveRelations::ConstitutiveModels<DisplacementDim> const models{
1339 this->solid_material_, *this->process_data_.phase_transition_model_};
1340
1341 auto const [ip_constitutive_data, ip_constitutive_variables] =
1343 Eigen::Map<Eigen::VectorXd const>(local_x.data(), local_x.size()),
1344 Eigen::Map<Eigen::VectorXd const>(local_x_prev.data(),
1345 local_x_prev.size()),
1346 t, dt, models);
1347
1348 auto const ip_d_data = updateConstitutiveVariablesDerivatives(
1349 Eigen::Map<Eigen::VectorXd const>(local_x.data(), local_x.size()),
1350 Eigen::Map<Eigen::VectorXd const>(local_x_prev.data(),
1351 local_x_prev.size()),
1352 t, dt, ip_constitutive_data, ip_constitutive_variables, models);
1353
1354 for (unsigned int_point = 0; int_point < n_integration_points; int_point++)
1355 {
1356 auto& ip = _ip_data[int_point];
1357 auto& ip_cd = ip_constitutive_data[int_point];
1358 auto& ip_dd = ip_d_data[int_point];
1359 auto& ip_cv = ip_constitutive_variables[int_point];
1360 auto& ip_out = this->output_data_[int_point];
1361 auto& current_state = this->current_states_[int_point];
1362 auto& prev_state = this->prev_states_[int_point];
1363
1364 auto const& Np = ip.N_p;
1365 auto const& NT = Np;
1366 auto const& Nu = ip.N_u;
1368 std::nullopt, this->element_.getID(),
1370 NumLib::interpolateCoordinates<ShapeFunctionDisplacement,
1372 this->element_, Nu))};
1373
1374 auto const& NpT = Np.transpose().eval();
1375 auto const& NTT = NT.transpose().eval();
1376
1377 auto const& gradNp = ip.dNdx_p;
1378 auto const& gradNT = gradNp;
1379 auto const& gradNu = ip.dNdx_u;
1380
1381 auto const& gradNpT = gradNp.transpose().eval();
1382 auto const& gradNTT = gradNT.transpose().eval();
1383
1384 auto const& w = ip.integration_weight;
1385
1386 auto const x_coord =
1387 NumLib::interpolateXCoordinate<ShapeFunctionDisplacement,
1389 this->element_, Nu);
1390
1391 auto const Bu =
1392 LinearBMatrix::computeBMatrix<DisplacementDim,
1393 ShapeFunctionDisplacement::NPOINTS,
1395 gradNu, Nu, x_coord, this->is_axially_symmetric_);
1396
1397 auto const NTN = (Np.transpose() * Np).eval();
1398 auto const BTI2N = (Bu.transpose() * Invariants::identity2 * Np).eval();
1399
1400 double const div_u_dot =
1401 Invariants::trace(Bu * (displacement - displacement_prev) / dt);
1402
1403 double const pGR = Np.dot(gas_pressure);
1404 double const pCap = Np.dot(capillary_pressure);
1405 double const T = NT.dot(temperature);
1406
1407 GlobalDimVectorType const gradpGR = gradNp * gas_pressure;
1408 GlobalDimVectorType const gradpCap = gradNp * capillary_pressure;
1409 GlobalDimVectorType const gradT = gradNT * temperature;
1410
1411 double const pGR_prev = Np.dot(gas_pressure_prev);
1412 double const pCap_prev = Np.dot(capillary_pressure_prev);
1413 double const T_prev = NT.dot(temperature_prev);
1414
1415 auto const& s_L = current_state.S_L_data.S_L;
1416 auto const s_L_dot = (s_L - prev_state.S_L_data->S_L) / dt;
1417
1418 auto const& b = this->process_data_.specific_body_force;
1419
1420 // ---------------------------------------------------------------------
1421 // C-component equation
1422 // ---------------------------------------------------------------------
1423
1424 MCpG.noalias() += NTN * (ip_cv.fC_4_MCpG.m * w);
1425 MCpC.noalias() += NTN * (ip_cv.fC_4_MCpC.m * w);
1426
1427 if (this->process_data_.apply_mass_lumping)
1428 {
1429 if (pCap - pCap_prev != 0.) // avoid division by Zero
1430 {
1431 MCpC.noalias() +=
1432 NTN * (ip_cv.fC_4_MCpC.ml / (pCap - pCap_prev) * w);
1433 }
1434 }
1435
1436 MCT.noalias() += NTN * (ip_cv.fC_4_MCT.m * w);
1437 // d (fC_4_MCT * T_dot)/d T
1438 local_Jac
1439 .template block<C_size, temperature_size>(C_index,
1441 .noalias() += NTN * (ip_dd.dfC_4_MCT.dT * (T - T_prev) / dt * w);
1442
1443 MCu.noalias() += BTI2N.transpose() * (ip_cv.fC_4_MCu.m * w);
1444 // d (fC_4_MCu * u_dot)/d T
1445 local_Jac
1446 .template block<C_size, temperature_size>(C_index,
1448 .noalias() += NTN * (ip_dd.dfC_4_MCu.dT * div_u_dot * w);
1449
1450 LCpG.noalias() += gradNpT * ip_cv.fC_4_LCpG.L * gradNp * w;
1451
1452 // d (fC_4_LCpG * grad p_GR)/d p_GR
1453 local_Jac.template block<C_size, C_size>(C_index, C_index).noalias() +=
1454 gradNpT * ip_dd.dfC_4_LCpG.dp_GR * gradpGR * Np * w;
1455
1456 // d (fC_4_LCpG * grad p_GR)/d p_cap
1457 local_Jac.template block<C_size, W_size>(C_index, W_index).noalias() +=
1458 gradNpT * ip_dd.dfC_4_LCpG.dp_cap * gradpGR * Np * w;
1459
1460 // d (fC_4_LCpG * grad p_GR)/d T
1461 local_Jac
1462 .template block<C_size, temperature_size>(C_index,
1464 .noalias() += gradNpT * ip_dd.dfC_4_LCpG.dT * gradpGR * NT * w;
1465
1466 // d (fC_4_MCpG * p_GR_dot)/d p_GR
1467 local_Jac.template block<C_size, C_size>(C_index, C_index).noalias() +=
1468 NTN * (ip_dd.dfC_4_MCpG.dp_GR * (pGR - pGR_prev) / dt * w);
1469
1470 // d (fC_4_MCpG * p_GR_dot)/d T
1471 local_Jac
1472 .template block<C_size, temperature_size>(C_index,
1474 .noalias() +=
1475 NTN * (ip_dd.dfC_4_MCpG.dT * (pGR - pGR_prev) / dt * w);
1476
1477 LCpC.noalias() -= gradNpT * ip_cv.fC_4_LCpC.L * gradNp * w;
1478
1479 /* TODO (naumov) This part is not tested by any of the current ctests.
1480 // d (fC_4_LCpC * grad p_cap)/d p_GR
1481 local_Jac.template block<C_size, C_size>(C_index, C_index).noalias() +=
1482 gradNpT * ip_dd.dfC_4_LCpC.dp_GR * gradpCap * Np * w;
1483 // d (fC_4_LCpC * grad p_cap)/d p_cap
1484 local_Jac.template block<C_size, W_size>(C_index, W_index).noalias() +=
1485 gradNpT * ip_dd.dfC_4_LCpC.dp_cap * gradpCap * Np * w;
1486
1487 local_Jac
1488 .template block<C_size, temperature_size>(C_index,
1489 temperature_index)
1490 .noalias() += gradNpT * ip_dd.dfC_4_LCpC.dT * gradpCap * Np * w;
1491 */
1492
1493 LCT.noalias() += gradNpT * ip_cv.fC_4_LCT.L * gradNp * w;
1494
1495 // fC_1
1496 fC.noalias() += gradNpT * ip_cv.fC_1.A * b * w;
1497
1498 if (!this->process_data_.apply_mass_lumping)
1499 {
1500 // fC_2 = \int a * s_L_dot
1501 fC.noalias() -= NpT * (ip_cv.fC_2a.a * s_L_dot * w);
1502
1503 local_Jac.template block<C_size, C_size>(C_index, C_index)
1504 .noalias() +=
1505 NTN * ((ip_dd.dfC_2a.dp_GR * s_L_dot
1506 /*- ip_cv.fC_2a.a * (ds_L_dp_GR = 0) / dt*/) *
1507 w);
1508
1509 local_Jac.template block<C_size, W_size>(C_index, W_index)
1510 .noalias() +=
1511 NTN * ((ip_dd.dfC_2a.dp_cap * s_L_dot +
1512 ip_cv.fC_2a.a * ip_dd.dS_L_dp_cap() / dt) *
1513 w);
1514
1515 local_Jac
1516 .template block<C_size, temperature_size>(C_index,
1518 .noalias() += NTN * (ip_dd.dfC_2a.dT * s_L_dot * w);
1519 }
1520 {
1521 // fC_3 = \int phi * a
1522 fC.noalias() -=
1523 NpT * (ip_out.porosity_data.phi * ip_cv.fC_3a.a * w);
1524
1525 local_Jac.template block<C_size, C_size>(C_index, C_index)
1526 .noalias() +=
1527 NTN * (ip_out.porosity_data.phi * ip_dd.dfC_3a.dp_GR * w);
1528
1529 local_Jac.template block<C_size, W_size>(C_index, W_index)
1530 .noalias() +=
1531 NTN * (ip_out.porosity_data.phi * ip_dd.dfC_3a.dp_cap * w);
1532
1533 local_Jac
1534 .template block<C_size, temperature_size>(C_index,
1536 .noalias() +=
1537 NTN * ((ip_dd.porosity_d_data.dphi_dT * ip_cv.fC_3a.a +
1538 ip_out.porosity_data.phi * ip_dd.dfC_3a.dT) *
1539 w);
1540 }
1541 // ---------------------------------------------------------------------
1542 // W-component equation
1543 // ---------------------------------------------------------------------
1544
1545 MWpG.noalias() += NTN * (ip_cv.fW_4_MWpG.m * w);
1546 MWpC.noalias() += NTN * (ip_cv.fW_4_MWpC.m * w);
1547
1548 if (this->process_data_.apply_mass_lumping)
1549 {
1550 if (pCap - pCap_prev != 0.) // avoid division by Zero
1551 {
1552 MWpC.noalias() +=
1553 NTN * (ip_cv.fW_4_MWpC.ml / (pCap - pCap_prev) * w);
1554 }
1555 }
1556
1557 MWT.noalias() += NTN * (ip_cv.fW_4_MWT.m * w);
1558
1559 MWu.noalias() += BTI2N.transpose() * (ip_cv.fW_4_MWu.m * w);
1560
1561 LWpG.noalias() += gradNpT * ip_cv.fW_4_LWpG.L * gradNp * w;
1562
1563 // fW_4 LWpG' parts; LWpG = \int grad (a + d) grad
1564 local_Jac.template block<W_size, C_size>(W_index, C_index).noalias() +=
1565 gradNpT * ip_dd.dfW_4_LWpG.dp_GR * gradpGR * Np * w;
1566
1567 local_Jac.template block<W_size, W_size>(W_index, W_index).noalias() +=
1568 gradNpT * ip_dd.dfW_4_LWpG.dp_cap * gradpGR * Np * w;
1569
1570 local_Jac
1571 .template block<W_size, temperature_size>(W_index,
1573 .noalias() += gradNpT * ip_dd.dfW_4_LWpG.dT * gradpGR * NT * w;
1574
1575 LWpC.noalias() += gradNpT * ip_cv.fW_4_LWpC.L * gradNp * w;
1576
1577 // fW_4 LWp_cap' parts; LWpC = \int grad (a + d) grad
1578 local_Jac.template block<W_size, C_size>(W_index, C_index).noalias() -=
1579 gradNpT * ip_dd.dfW_4_LWpC.dp_GR * gradpCap * Np * w;
1580
1581 local_Jac.template block<W_size, W_size>(W_index, W_index).noalias() -=
1582 gradNpT * ip_dd.dfW_4_LWpC.dp_cap * gradpCap * Np * w;
1583
1584 local_Jac
1585 .template block<W_size, temperature_size>(W_index,
1587 .noalias() -= gradNpT * ip_dd.dfW_4_LWpC.dT * gradpCap * NT * w;
1588
1589 LWT.noalias() += gradNpT * ip_cv.fW_4_LWT.L * gradNp * w;
1590
1591 // fW_1
1592 fW.noalias() += gradNpT * ip_cv.fW_1.A * b * w;
1593
1594 // fW_2 = \int a * s_L_dot
1595 if (!this->process_data_.apply_mass_lumping)
1596 {
1597 fW.noalias() -= NpT * (ip_cv.fW_2.a * s_L_dot * w);
1598
1599 local_Jac.template block<W_size, C_size>(W_index, C_index)
1600 .noalias() += NTN * (ip_dd.dfW_2.dp_GR * s_L_dot * w);
1601
1602 // sign negated because of dp_cap = -dp_LR
1603 // TODO (naumov) Had to change the sign to get equal Jacobian WW
1604 // blocks in A2 Test. Where is the error?
1605 local_Jac.template block<W_size, W_size>(W_index, W_index)
1606 .noalias() += NTN * ((ip_dd.dfW_2.dp_cap * s_L_dot +
1607 ip_cv.fW_2.a * ip_dd.dS_L_dp_cap() / dt) *
1608 w);
1609
1610 local_Jac
1611 .template block<W_size, temperature_size>(W_index,
1613 .noalias() += NTN * (ip_dd.dfW_2.dT * s_L_dot * w);
1614 }
1615
1616 // fW_3 = \int phi * a
1617 fW.noalias() -= NpT * (ip_out.porosity_data.phi * ip_cv.fW_3a.a * w);
1618
1619 local_Jac.template block<W_size, C_size>(W_index, C_index).noalias() +=
1620 NTN * (ip_out.porosity_data.phi * ip_dd.dfW_3a.dp_GR * w);
1621
1622 local_Jac.template block<W_size, W_size>(W_index, W_index).noalias() +=
1623 NTN * (ip_out.porosity_data.phi * ip_dd.dfW_3a.dp_cap * w);
1624
1625 local_Jac
1626 .template block<W_size, temperature_size>(W_index,
1628 .noalias() +=
1629 NTN * ((ip_dd.porosity_d_data.dphi_dT * ip_cv.fW_3a.a +
1630 ip_out.porosity_data.phi * ip_dd.dfW_3a.dT) *
1631 w);
1632
1633 // ---------------------------------------------------------------------
1634 // - temperature equation
1635 // ---------------------------------------------------------------------
1636
1637 MTu.noalias() +=
1638 BTI2N.transpose() *
1639 (ip_cv.effective_volumetric_enthalpy_data.rho_h_eff * w);
1640
1641 // dfT_4/dp_GR
1642 // d (MTu * u_dot)/dp_GR
1643 local_Jac
1644 .template block<temperature_size, C_size>(temperature_index,
1645 C_index)
1646 .noalias() +=
1647 NTN * (ip_dd.effective_volumetric_enthalpy_d_data.drho_h_eff_dp_GR *
1648 div_u_dot * w);
1649
1650 // dfT_4/dp_cap
1651 // d (MTu * u_dot)/dp_cap
1652 local_Jac
1653 .template block<temperature_size, W_size>(temperature_index,
1654 W_index)
1655 .noalias() -=
1656 NTN *
1657 (ip_dd.effective_volumetric_enthalpy_d_data.drho_h_eff_dp_cap *
1658 div_u_dot * w);
1659
1660 // dfT_4/dT
1661 // d (MTu * u_dot)/dT
1662 local_Jac
1663 .template block<temperature_size, temperature_size>(
1665 .noalias() +=
1666 NTN * (ip_dd.effective_volumetric_enthalpy_d_data.drho_h_eff_dT *
1667 div_u_dot * w);
1668
1669 KTT.noalias() +=
1670 gradNTT * ip_cv.thermal_conductivity_data.lambda * gradNT * w;
1671
1672 // d KTT/dp_GR * T
1673 // TODO (naumov) always zero if lambda_xR have no derivatives wrt. p_GR.
1674 // dlambda_dp_GR =
1675 // (dphi_G_dp_GR = 0) * lambdaGR + phi_G * dlambda_GR_dp_GR +
1676 // (dphi_L_dp_GR = 0) * lambdaLR + phi_L * dlambda_LR_dp_GR +
1677 // (dphi_S_dp_GR = 0) * lambdaSR + phi_S * dlambda_SR_dp_GR +
1678 // = 0
1679 //
1680 // Since dlambda/dp_GR is 0 the derivative is omitted:
1681 // local_Jac
1682 // .template block<temperature_size, C_size>(temperature_index,
1683 // C_index)
1684 // .noalias() += gradNTT * dlambda_dp_GR * gradT * Np * w;
1685
1686 // d KTT/dp_cap * T
1687 local_Jac
1688 .template block<temperature_size, W_size>(temperature_index,
1689 W_index)
1690 .noalias() += gradNTT *
1691 ip_dd.thermal_conductivity_d_data.dlambda_dp_cap *
1692 gradT * Np * w;
1693
1694 // d KTT/dT * T
1695 local_Jac
1696 .template block<temperature_size, temperature_size>(
1698 .noalias() += gradNTT *
1699 ip_dd.thermal_conductivity_d_data.dlambda_dT * gradT *
1700 NT * w;
1701
1702 // fT_1
1703 fT.noalias() -= NTT * (ip_cv.fT_1.m * w);
1704
1705 // dfT_1/dp_GR
1706 local_Jac
1707 .template block<temperature_size, C_size>(temperature_index,
1708 C_index)
1709 .noalias() += NTN * (ip_dd.dfT_1.dp_GR * w);
1710
1711 // dfT_1/dp_cap
1712 local_Jac
1713 .template block<temperature_size, W_size>(temperature_index,
1714 W_index)
1715 .noalias() += NTN * (ip_dd.dfT_1.dp_cap * w);
1716
1717 // dfT_1/dT
1718 // MTT
1719 local_Jac
1720 .template block<temperature_size, temperature_size>(
1722 .noalias() += NTN * (ip_dd.dfT_1.dT * w);
1723
1724 // fT_2
1725 fT.noalias() += gradNTT * ip_cv.fT_2.A * w;
1726
1727 // dfT_2/dp_GR
1728 local_Jac
1729 .template block<temperature_size, C_size>(temperature_index,
1730 C_index)
1731 .noalias() -=
1732 // dfT_2/dp_GR first part
1733 gradNTT * ip_dd.dfT_2.dp_GR_Npart * Np * w +
1734 // dfT_2/dp_GR second part
1735 gradNTT * ip_dd.dfT_2.dp_GR_gradNpart * gradNp * w;
1736
1737 // dfT_2/dp_cap
1738 local_Jac
1739 .template block<temperature_size, W_size>(temperature_index,
1740 W_index)
1741 .noalias() -=
1742 // first part of dfT_2/dp_cap
1743 gradNTT * (-ip_dd.dfT_2.dp_cap_Npart) * Np * w +
1744 // second part of dfT_2/dp_cap
1745 gradNTT * (-ip_dd.dfT_2.dp_cap_gradNpart) * gradNp * w;
1746
1747 // dfT_2/dT
1748 local_Jac
1749 .template block<temperature_size, temperature_size>(
1751 .noalias() -= gradNTT * ip_dd.dfT_2.dT * NT * w;
1752
1753 // fT_3
1754 fT.noalias() += NTT * (ip_cv.fT_3.N * w);
1755
1756 fT.noalias() += gradNTT * ip_cv.fT_3.gradN * w;
1757
1758 // ---------------------------------------------------------------------
1759 // - displacement equation
1760 // ---------------------------------------------------------------------
1761
1762 KUpG.noalias() -= BTI2N * (ip_cv.biot_data() * w);
1763
1764 // dfU_2/dp_GR = dKUpG/dp_GR * p_GR + KUpG. The former is zero, the
1765 // latter is handled below.
1766
1767 KUpC.noalias() += BTI2N * (ip_cv.fu_2_KupC.m * w);
1768
1769 // dfU_2/dp_cap = dKUpC/dp_cap * p_cap + KUpC. The former is handled
1770 // here, the latter below.
1771 local_Jac
1772 .template block<displacement_size, W_size>(displacement_index,
1773 W_index)
1774 .noalias() += BTI2N * (ip_dd.dfu_2_KupC.dp_cap * w);
1775
1776 local_Jac
1777 .template block<displacement_size, displacement_size>(
1779 .noalias() +=
1780 Bu.transpose() * ip_cd.s_mech_data.stiffness_tensor * Bu * w;
1781
1782 // fU_1
1783 fU.noalias() -=
1784 (Bu.transpose() * current_state.eff_stress_data.sigma -
1785 N_u_op(Nu).transpose() * ip_cv.volumetric_body_force()) *
1786 w;
1787
1788 // KuT
1789 local_Jac
1790 .template block<displacement_size, temperature_size>(
1792 .noalias() -= Bu.transpose() * ip_dd.dfu_1_KuT.dT * NT * w;
1793
1794 /* TODO (naumov) Test with gravity needed to check this Jacobian part.
1795 local_Jac
1796 .template block<displacement_size, temperature_size>(
1797 displacement_index, temperature_index)
1798 .noalias() += N_u_op(Nu).transpose() * ip_cv.drho_dT * b *
1799 N_u_op(Nu).transpose() * w;
1800 */
1801
1802 if (this->process_data_.apply_mass_lumping)
1803 {
1804 MCpG = MCpG.colwise().sum().eval().asDiagonal();
1805 MCpC = MCpC.colwise().sum().eval().asDiagonal();
1806 MWpG = MWpG.colwise().sum().eval().asDiagonal();
1807 MWpC = MWpC.colwise().sum().eval().asDiagonal();
1808 }
1809 } // int_point-loop
1810
1811 // --- Gas ---
1812 // fC_4
1813 fC.noalias() -= LCpG * gas_pressure + LCpC * capillary_pressure +
1814 LCT * temperature +
1815 MCpG * (gas_pressure - gas_pressure_prev) / dt +
1816 MCpC * (capillary_pressure - capillary_pressure_prev) / dt +
1817 MCT * (temperature - temperature_prev) / dt +
1818 MCu * (displacement - displacement_prev) / dt;
1819
1820 local_Jac.template block<C_size, C_size>(C_index, C_index).noalias() +=
1821 LCpG + MCpG / dt;
1822 local_Jac.template block<C_size, W_size>(C_index, W_index).noalias() +=
1823 LCpC + MCpC / dt;
1824 local_Jac
1825 .template block<C_size, temperature_size>(C_index, temperature_index)
1826 .noalias() += LCT + MCT / dt;
1827 local_Jac
1828 .template block<C_size, displacement_size>(C_index, displacement_index)
1829 .noalias() += MCu / dt;
1830
1831 // --- Capillary pressure ---
1832 // fW_4
1833 fW.noalias() -= LWpG * gas_pressure + LWpC * capillary_pressure +
1834 LWT * temperature +
1835 MWpG * (gas_pressure - gas_pressure_prev) / dt +
1836 MWpC * (capillary_pressure - capillary_pressure_prev) / dt +
1837 MWT * (temperature - temperature_prev) / dt +
1838 MWu * (displacement - displacement_prev) / dt;
1839
1840 local_Jac.template block<W_size, W_size>(W_index, W_index).noalias() +=
1841 LWpC + MWpC / dt;
1842 local_Jac.template block<W_size, C_size>(W_index, C_index).noalias() +=
1843 LWpG + MWpG / dt;
1844 local_Jac
1845 .template block<W_size, temperature_size>(W_index, temperature_index)
1846 .noalias() += LWT + MWT / dt;
1847 local_Jac
1848 .template block<W_size, displacement_size>(W_index, displacement_index)
1849 .noalias() += MWu / dt;
1850
1851 // --- Temperature ---
1852 // fT_4
1853 fT.noalias() -=
1854 KTT * temperature + MTu * (displacement - displacement_prev) / dt;
1855
1856 local_Jac
1857 .template block<temperature_size, temperature_size>(temperature_index,
1859 .noalias() += KTT;
1860 local_Jac
1861 .template block<temperature_size, displacement_size>(temperature_index,
1863 .noalias() += MTu / dt;
1864
1865 // --- Displacement ---
1866 // fU_2
1867 fU.noalias() -= KUpG * gas_pressure + KUpC * capillary_pressure;
1868
1869 local_Jac
1870 .template block<displacement_size, C_size>(displacement_index, C_index)
1871 .noalias() += KUpG;
1872 local_Jac
1873 .template block<displacement_size, W_size>(displacement_index, W_index)
1874 .noalias() += KUpC;
1875}
std::vector< ConstitutiveRelations::DerivativesData< DisplacementDim > > updateConstitutiveVariablesDerivatives(Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, double const t, double const dt, std::vector< ConstitutiveRelations::ConstitutiveData< DisplacementDim > > const &ip_constitutive_data, std::vector< ConstitutiveRelations::ConstitutiveTempData< DisplacementDim > > const &ip_constitutive_variables, ConstitutiveRelations::ConstitutiveModels< DisplacementDim > const &models)
typename ShapeMatricesTypePressure::GlobalDimVectorType GlobalDimVectorType
Definition TH2MFEM.h:68
static double trace(Eigen::Matrix< double, KelvinVectorSize, 1 > const &v)
Trace of the corresponding tensor.

References MathLib::createZeroedMatrix(), MathLib::createZeroedVector(), NumLib::interpolateCoordinates(), and NumLib::interpolateXCoordinate().

◆ computeSecondaryVariableConcrete()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
void ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::computeSecondaryVariableConcrete ( double const t,
double const dt,
Eigen::VectorXd const & local_x,
Eigen::VectorXd const & local_x_prev )
overrideprivatevirtual

Reimplemented from ProcessLib::LocalAssemblerInterface.

Definition at line 1880 of file TH2MFEM-impl.h.

1884{
1885 auto const gas_pressure =
1886 local_x.template segment<gas_pressure_size>(gas_pressure_index);
1887 auto const capillary_pressure =
1888 local_x.template segment<capillary_pressure_size>(
1890 auto const liquid_pressure = (gas_pressure - capillary_pressure).eval();
1891
1893 ShapeFunctionPressure, typename ShapeFunctionDisplacement::MeshElement,
1894 DisplacementDim>(this->element_, this->is_axially_symmetric_,
1895 gas_pressure,
1896 *this->process_data_.gas_pressure_interpolated);
1897
1899 ShapeFunctionPressure, typename ShapeFunctionDisplacement::MeshElement,
1900 DisplacementDim>(this->element_, this->is_axially_symmetric_,
1902 *this->process_data_.capillary_pressure_interpolated);
1903
1905 ShapeFunctionPressure, typename ShapeFunctionDisplacement::MeshElement,
1906 DisplacementDim>(this->element_, this->is_axially_symmetric_,
1907 liquid_pressure,
1908 *this->process_data_.liquid_pressure_interpolated);
1909
1910 auto const temperature =
1911 local_x.template segment<temperature_size>(temperature_index);
1912
1914 ShapeFunctionPressure, typename ShapeFunctionDisplacement::MeshElement,
1915 DisplacementDim>(this->element_, this->is_axially_symmetric_,
1916 temperature,
1917 *this->process_data_.temperature_interpolated);
1918
1919 ConstitutiveRelations::ConstitutiveModels<DisplacementDim> const models{
1920 this->solid_material_, *this->process_data_.phase_transition_model_};
1921
1922 updateConstitutiveVariables(local_x, local_x_prev, t, dt, models);
1923}
void interpolateToHigherOrderNodes(MeshLib::Element const &element, bool const is_axially_symmetric, Eigen::MatrixBase< EigenMatrixType > const &node_values, MeshLib::PropertyVector< double > &interpolated_values_global_vector)

References NumLib::interpolateToHigherOrderNodes().

◆ getShapeMatrix()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
Eigen::Map< const Eigen::RowVectorXd > ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::getShapeMatrix ( const unsigned integration_point) const
inlineoverrideprivatevirtual

Provides the shape matrix at the given integration point.

Implements NumLib::ExtrapolatableElement.

Definition at line 180 of file TH2MFEM.h.

182 {
183 auto const& N_u = _secondary_data.N_u[integration_point];
184
185 // assumes N is stored contiguously in memory
186 return Eigen::Map<const Eigen::RowVectorXd>(N_u.data(), N_u.size());
187 }

References ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::_secondary_data, and ProcessLib::TH2M::SecondaryData< ShapeMatrixType >::N_u.

◆ getVectorDeformationSegment()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
virtual std::optional< VectorSegment > ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::getVectorDeformationSegment ( ) const
inlineoverrideprivatevirtual

◆ initializeConcrete()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
void ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::initializeConcrete ( )
inlineoverrideprivatevirtual

Set initial stress from parameter.

Reimplemented from ProcessLib::LocalAssemblerInterface.

Definition at line 115 of file TH2MFEM.h.

116 {
117 unsigned const n_integration_points =
119
120 for (unsigned ip = 0; ip < n_integration_points; ip++)
121 {
122 auto& ip_data = _ip_data[ip];
123
124 ParameterLib::SpatialPosition const x_position{
125 std::nullopt, this->element_.getID(),
127 ShapeFunctionDisplacement,
129 ip_data.N_u))};
130
132 if (this->process_data_.initial_stress.value)
133 {
134 this->current_states_[ip].eff_stress_data.sigma.noalias() =
136 DisplacementDim>(
137 (*this->process_data_.initial_stress.value)(
138 std::numeric_limits<
139 double>::quiet_NaN() /* time independent */,
140 x_position));
141 }
142
143 double const t = 0; // TODO (naumov) pass t from top
144 auto& material_state = this->material_states_[ip];
145 this->solid_material_.initializeInternalStateVariables(
146 t, x_position, *material_state.material_state_variables);
147
148 material_state.pushBackState();
149 }
150
151 for (unsigned ip = 0; ip < n_integration_points; ip++)
152 {
153 this->prev_states_[ip] = this->current_states_[ip];
154 }
155 }
Eigen::Matrix< double, Eigen::MatrixBase< Derived >::RowsAtCompileTime, 1 > symmetricTensorToKelvinVector(Eigen::MatrixBase< Derived > const &v)
std::vector< ConstitutiveRelations::MaterialStateData< DisplacementDim > > material_states_

References ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::_ip_data, ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::current_states_, ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::element_, MeshLib::Element::getID(), NumLib::GenericIntegrationMethod::getNumberOfPoints(), ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::integration_method_, NumLib::interpolateCoordinates(), ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::material_states_, ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::prev_states_, ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::process_data_, ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::solid_material_, and MathLib::KelvinVector::symmetricTensorToKelvinVector().

◆ postTimestepConcrete()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
void ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::postTimestepConcrete ( Eigen::VectorXd const & ,
Eigen::VectorXd const & ,
double const ,
double const ,
int const  )
inlineoverrideprivatevirtual

Reimplemented from ProcessLib::LocalAssemblerInterface.

Definition at line 157 of file TH2MFEM.h.

161 {
162 unsigned const n_integration_points =
164
165 for (unsigned ip = 0; ip < n_integration_points; ip++)
166 {
167 this->material_states_[ip].pushBackState();
168 }
169
170 for (unsigned ip = 0; ip < n_integration_points; ip++)
171 {
172 this->prev_states_[ip] = this->current_states_[ip];
173 }
174 }

References ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::current_states_, NumLib::GenericIntegrationMethod::getNumberOfPoints(), ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::integration_method_, ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::material_states_, and ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >::prev_states_.

◆ setInitialConditionsConcrete()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
void ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::setInitialConditionsConcrete ( Eigen::VectorXd const local_x,
double const t,
int const process_id )
overrideprivatevirtual

Reimplemented from ProcessLib::LocalAssemblerInterface.

Definition at line 798 of file TH2MFEM-impl.h.

802{
803 [[maybe_unused]] auto const matrix_size =
806
807 assert(local_x.size() == matrix_size);
808
809 auto const capillary_pressure =
810 local_x.template segment<capillary_pressure_size>(
812
813 auto const p_GR =
814 local_x.template segment<gas_pressure_size>(gas_pressure_index);
815
816 auto const temperature =
817 local_x.template segment<temperature_size>(temperature_index);
818
819 auto const displacement =
820 local_x.template segment<displacement_size>(displacement_index);
821
822 constexpr double dt = std::numeric_limits<double>::quiet_NaN();
823 auto const& medium =
824 *this->process_data_.media_map.getMedium(this->element_.getID());
825 auto const& solid_phase = medium.phase("Solid");
826
827 ConstitutiveRelations::ConstitutiveModels<DisplacementDim> const models{
828 this->solid_material_, *this->process_data_.phase_transition_model_};
829
830 unsigned const n_integration_points =
832
833 for (unsigned ip = 0; ip < n_integration_points; ip++)
834 {
836
837 auto& ip_data = _ip_data[ip];
838 auto& ip_out = this->output_data_[ip];
839 auto& prev_state = this->prev_states_[ip];
840 auto const& Np = ip_data.N_p;
841 auto const& NT = Np;
842 auto const& Nu = ip_data.N_u;
843 auto const& gradNu = ip_data.dNdx_u;
844 auto const x_coord =
845 NumLib::interpolateXCoordinate<ShapeFunctionDisplacement,
847 this->element_, Nu);
849 std::nullopt, this->element_.getID(),
851 NumLib::interpolateCoordinates<ShapeFunctionDisplacement,
853 this->element_, ip_data.N_u))};
854
855 double const pCap = Np.dot(capillary_pressure);
856 vars.capillary_pressure = pCap;
857
858 double const T = NT.dot(temperature);
859 ConstitutiveRelations::TemperatureData const T_data{
860 T, T}; // T_prev = T in initialization.
861 vars.temperature = T;
862
863 auto const Bu =
864 LinearBMatrix::computeBMatrix<DisplacementDim,
865 ShapeFunctionDisplacement::NPOINTS,
867 gradNu, Nu, x_coord, this->is_axially_symmetric_);
868
869 auto& eps = ip_out.eps_data.eps;
870 eps.noalias() = Bu * displacement;
871
872 // Set volumetric strain rate for the general case without swelling.
874
875 double const S_L =
876 medium.property(MPL::PropertyType::saturation)
877 .template value<double>(
878 vars, pos, t, std::numeric_limits<double>::quiet_NaN());
879 this->prev_states_[ip].S_L_data->S_L = S_L;
880
881 // TODO (naumov) Double computation of C_el might be avoided if
882 // updateConstitutiveVariables is called before. But it might interfere
883 // with eps_m initialization.
884 ConstitutiveRelations::ElasticTangentStiffnessData<DisplacementDim>
885 C_el_data;
886 models.elastic_tangent_stiffness_model.eval({pos, t, dt}, T_data,
887 C_el_data);
888 auto const& C_el = C_el_data.stiffness_tensor;
889
890 // Set eps_m_prev from potentially non-zero eps and sigma_sw from
891 // restart.
892 auto const& sigma_sw = this->current_states_[ip].swelling_data.sigma_sw;
893 prev_state.mechanical_strain_data->eps_m.noalias() =
894 solid_phase.hasProperty(MPL::PropertyType::swelling_stress_rate)
895 ? eps + C_el.inverse() * sigma_sw
896 : eps;
897
898 if (this->process_data_.initial_stress.isTotalStress())
899 {
900 auto const alpha_b =
901 medium.property(MPL::PropertyType::biot_coefficient)
902 .template value<double>(vars, pos, t, 0.0 /*dt*/);
903
904 vars.liquid_saturation = S_L;
905 double const bishop =
906 medium.property(MPL::PropertyType::bishops_effective_stress)
907 .template value<double>(vars, pos, t, 0.0 /*dt*/);
908
909 this->current_states_[ip].eff_stress_data.sigma.noalias() +=
910 alpha_b * Np.dot(p_GR - bishop * capillary_pressure) *
912 this->prev_states_[ip].eff_stress_data =
913 this->current_states_[ip].eff_stress_data;
914 }
915 }
916
917 // local_x_prev equal to local_x s.t. the local_x_dot is zero.
918 updateConstitutiveVariables(local_x, local_x, t, 0, models);
919
920 for (unsigned ip = 0; ip < n_integration_points; ip++)
921 {
922 this->material_states_[ip].pushBackState();
923 this->prev_states_[ip] = this->current_states_[ip];
924 }
925}

References MaterialPropertyLib::VariableArray::capillary_pressure, NumLib::interpolateCoordinates(), NumLib::interpolateXCoordinate(), MaterialPropertyLib::VariableArray::liquid_saturation, ProcessLib::TH2M::ConstitutiveRelations::ElasticTangentStiffnessData< DisplacementDim >::stiffness_tensor, MaterialPropertyLib::VariableArray::temperature, and MaterialPropertyLib::VariableArray::volumetric_strain.

◆ setIPDataInitialConditions()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
std::size_t ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::setIPDataInitialConditions ( std::string_view const name,
double const * values,
int const integration_order )
overrideprivatevirtual
Returns
the number of read integration points.

Implements ProcessLib::TH2M::LocalAssemblerInterface< DisplacementDim >.

Definition at line 738 of file TH2MFEM-impl.h.

741{
742 if (integration_order !=
743 static_cast<int>(this->integration_method_.getIntegrationOrder()))
744 {
745 OGS_FATAL(
746 "Setting integration point initial conditions; The integration "
747 "order of the local assembler for element {:d} is different "
748 "from the integration order in the initial condition.",
749 this->element_.getID());
750 }
751
752 if (name == "sigma" && this->process_data_.initial_stress.value)
753 {
754 OGS_FATAL(
755 "Setting initial conditions for stress from integration "
756 "point data and from a parameter '{:s}' is not possible "
757 "simultaneously.",
758 this->process_data_.initial_stress.value->name);
759 }
760
761 if (name.starts_with("material_state_variable_"))
762 {
763 name.remove_prefix(24);
764 DBUG("Setting material state variable '{:s}'", name);
765
766 auto const& internal_variables =
767 this->solid_material_.getInternalVariables();
768 if (auto const iv = std::find_if(
769 begin(internal_variables), end(internal_variables),
770 [&name](auto const& iv) { return iv.name == name; });
771 iv != end(internal_variables))
772 {
773 DBUG("Setting material state variable '{:s}'", name);
775 values, this->material_states_,
776 &ConstitutiveRelations::MaterialStateData<
777 DisplacementDim>::material_state_variables,
778 iv->reference);
779 }
780
781 WARN(
782 "Could not find variable {:s} in solid material model's "
783 "internal variables.",
784 name);
785 return 0;
786 }
787
788 // TODO this logic could be pulled out of the local assembler into the
789 // process. That might lead to a slightly better performance due to less
790 // string comparisons.
792 name, values, this->current_states_);
793}
#define OGS_FATAL(...)
Definition Error.h:26
void DBUG(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:30
void WARN(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:40
std::size_t reflectSetIPData(std::string_view const name, double const *values, std::vector< IPData > &ip_data_vector)
std::size_t setIntegrationPointDataMaterialStateVariables(double const *values, IntegrationPointDataVector &ip_data_vector, MemberType member, std::function< std::span< double >(MaterialStateVariables &)> get_values_span)

References DBUG(), OGS_FATAL, ProcessLib::Reflection::reflectSetIPData(), ProcessLib::setIntegrationPointDataMaterialStateVariables(), and WARN().

◆ updateConstitutiveVariables()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
std::tuple< std::vector< ConstitutiveRelations::ConstitutiveData< DisplacementDim > >, std::vector< ConstitutiveRelations::ConstitutiveTempData< DisplacementDim > > > ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::updateConstitutiveVariables ( Eigen::VectorXd const & local_x,
Eigen::VectorXd const & local_x_prev,
double const t,
double const dt,
ConstitutiveRelations::ConstitutiveModels< DisplacementDim > const & models )
private

Definition at line 87 of file TH2MFEM-impl.h.

93{
94 [[maybe_unused]] auto const matrix_size =
97
98 assert(local_x.size() == matrix_size);
99
100 auto const gas_pressure =
101 local_x.template segment<gas_pressure_size>(gas_pressure_index);
102 auto const capillary_pressure =
103 local_x.template segment<capillary_pressure_size>(
105
106 auto const temperature =
107 local_x.template segment<temperature_size>(temperature_index);
108 auto const temperature_prev =
109 local_x_prev.template segment<temperature_size>(temperature_index);
110
111 auto const displacement =
112 local_x.template segment<displacement_size>(displacement_index);
113 auto const displacement_prev =
114 local_x_prev.template segment<displacement_size>(displacement_index);
115
116 auto const& medium =
117 *this->process_data_.media_map.getMedium(this->element_.getID());
118 ConstitutiveRelations::MediaData media_data{medium};
119
120 unsigned const n_integration_points =
122
123 std::vector<ConstitutiveRelations::ConstitutiveData<DisplacementDim>>
124 ip_constitutive_data(n_integration_points);
125 std::vector<ConstitutiveRelations::ConstitutiveTempData<DisplacementDim>>
126 ip_constitutive_variables(n_integration_points);
127
128 for (unsigned ip = 0; ip < n_integration_points; ip++)
129 {
130 auto& ip_data = _ip_data[ip];
131 auto& ip_cv = ip_constitutive_variables[ip];
132 auto& ip_cd = ip_constitutive_data[ip];
133 auto& ip_out = this->output_data_[ip];
134 auto& current_state = this->current_states_[ip];
135 auto& prev_state = this->prev_states_[ip];
136
137 auto const& Np = ip_data.N_p;
138 auto const& NT = Np;
139 auto const& Nu = ip_data.N_u;
140 auto const& gradNu = ip_data.dNdx_u;
141 auto const& gradNp = ip_data.dNdx_p;
143 std::nullopt, this->element_.getID(),
145 NumLib::interpolateCoordinates<ShapeFunctionDisplacement,
147 this->element_, Nu))};
148 auto const x_coord =
149 NumLib::interpolateXCoordinate<ShapeFunctionDisplacement,
151 this->element_, Nu);
152
153 double const T = NT.dot(temperature);
154 double const T_prev = NT.dot(temperature_prev);
155 ConstitutiveRelations::TemperatureData const T_data{T, T_prev};
157 Np.dot(gas_pressure)};
159 Np.dot(capillary_pressure)};
161 this->process_data_.reference_temperature(t, pos)[0]};
163 grad_p_GR{gradNp * gas_pressure};
165 DisplacementDim> const grad_p_cap{gradNp * capillary_pressure};
167 grad_T{gradNp * temperature};
168
169 // medium properties
170 models.elastic_tangent_stiffness_model.eval({pos, t, dt}, T_data,
171 ip_cv.C_el_data);
172
173 models.biot_model.eval({pos, t, dt}, media_data, ip_cv.biot_data);
174
175 auto const Bu =
176 LinearBMatrix::computeBMatrix<DisplacementDim,
177 ShapeFunctionDisplacement::NPOINTS,
179 gradNu, Nu, x_coord, this->is_axially_symmetric_);
180
181 ip_out.eps_data.eps.noalias() = Bu * displacement;
182 models.S_L_model.eval({pos, t, dt}, media_data, pCap_data,
183 current_state.S_L_data);
184
185 models.chi_S_L_model.eval({pos, t, dt}, media_data,
186 current_state.S_L_data, ip_cv.chi_S_L);
187
188 // solid phase compressibility
189 models.beta_p_SR_model.eval({pos, t, dt}, ip_cv.biot_data,
190 ip_cv.C_el_data, ip_cv.beta_p_SR);
191
192 // If there is swelling stress rate, compute swelling stress.
193 models.swelling_model.eval(
194 {pos, t, dt}, media_data, ip_cv.C_el_data, current_state.S_L_data,
195 prev_state.S_L_data, prev_state.swelling_data,
196 current_state.swelling_data, ip_cv.swelling_data);
197
198 // solid phase linear thermal expansion coefficient
199 models.s_therm_exp_model.eval({pos, t, dt}, media_data, T_data, T0,
200 ip_cv.s_therm_exp_data);
201
202 models.mechanical_strain_model.eval(
203 T_data, ip_cv.s_therm_exp_data, ip_out.eps_data,
204 Bu * displacement_prev, prev_state.mechanical_strain_data,
205 ip_cv.swelling_data, current_state.mechanical_strain_data);
206
207 models.s_mech_model.eval(
208 {pos, t, dt}, T_data, current_state.mechanical_strain_data,
209 prev_state.mechanical_strain_data, prev_state.eff_stress_data,
210 current_state.eff_stress_data, this->material_states_[ip],
211 ip_cd.s_mech_data, ip_cv.equivalent_plastic_strain_data);
212
213 models.total_stress_model.eval(current_state.eff_stress_data,
214 ip_cv.biot_data, ip_cv.chi_S_L, pGR_data,
215 pCap_data, ip_cv.total_stress_data);
216
217 models.permeability_model.eval(
218 {pos, t, dt}, media_data, current_state.S_L_data, pCap_data, T_data,
219 ip_cv.total_stress_data, ip_out.eps_data,
220 ip_cv.equivalent_plastic_strain_data, ip_out.permeability_data);
221
222 models.pure_liquid_density_model.eval({pos, t, dt}, media_data,
223 pGR_data, pCap_data, T_data,
224 current_state.rho_W_LR);
225
226 models.phase_transition_model.eval(
227 {pos, t, dt}, media_data, pGR_data, pCap_data, T_data,
228 current_state.rho_W_LR, ip_out.fluid_enthalpy_data,
229 ip_out.mass_mole_fractions_data, ip_out.fluid_density_data,
230 ip_out.vapour_pressure_data, current_state.constituent_density_data,
231 ip_cv.phase_transition_data);
232
233 models.viscosity_model.eval({pos, t, dt}, media_data, T_data,
234 ip_out.mass_mole_fractions_data,
235 ip_cv.viscosity_data);
236
237 models.porosity_model.eval({pos, t, dt}, media_data,
238#ifdef NON_CONSTANT_SOLID_PHASE_VOLUME_FRACTION
239 ip_cv.biot_data, ip_out.eps_data,
240 ip_cv.s_therm_exp_data,
241#endif // NON_CONSTANT_SOLID_PHASE_VOLUME_FRACTION
242 ip_out.porosity_data);
243
244 models.solid_density_model.eval({pos, t, dt}, media_data, T_data,
245#ifdef NON_CONSTANT_SOLID_PHASE_VOLUME_FRACTION
246 ip_cv.biot_data, ip_out.eps_data,
247 ip_cv.s_therm_exp_data,
248#endif // NON_CONSTANT_SOLID_PHASE_VOLUME_FRACTION
249 ip_out.solid_density_data);
250
251 models.solid_heat_capacity_model.eval({pos, t, dt}, media_data, T_data,
252 ip_cv.solid_heat_capacity_data);
253
254 models.thermal_conductivity_model.eval(
255 {pos, t, dt}, media_data, T_data, ip_out.porosity_data,
256 current_state.S_L_data, ip_cv.thermal_conductivity_data);
257
258 models.advection_model.eval(current_state.constituent_density_data,
259 ip_out.permeability_data,
260 current_state.rho_W_LR,
261 ip_cv.viscosity_data,
262 ip_cv.advection_data);
263
264 models.gravity_model.eval(
265 ip_out.fluid_density_data,
266 ip_out.porosity_data,
267 current_state.S_L_data,
268 ip_out.solid_density_data,
270 this->process_data_.specific_body_force},
271 ip_cv.volumetric_body_force);
272
273 models.diffusion_velocity_model.eval(grad_p_cap,
274 grad_p_GR,
275 ip_out.mass_mole_fractions_data,
276 ip_cv.phase_transition_data,
277 ip_out.porosity_data,
278 current_state.S_L_data,
279 grad_T,
280 ip_out.diffusion_velocity_data);
281
282 models.solid_enthalpy_model.eval(ip_cv.solid_heat_capacity_data, T_data,
283 ip_out.solid_enthalpy_data);
284
285 models.internal_energy_model.eval(ip_out.fluid_density_data,
286 ip_cv.phase_transition_data,
287 ip_out.porosity_data,
288 current_state.S_L_data,
289 ip_out.solid_density_data,
290 ip_out.solid_enthalpy_data,
291 current_state.internal_energy_data);
292
293 models.effective_volumetric_enthalpy_model.eval(
294 ip_out.fluid_density_data,
295 ip_out.fluid_enthalpy_data,
296 ip_out.porosity_data,
297 current_state.S_L_data,
298 ip_out.solid_density_data,
299 ip_out.solid_enthalpy_data,
300 ip_cv.effective_volumetric_enthalpy_data);
301
302 models.fC_1_model.eval(ip_cv.advection_data, ip_out.fluid_density_data,
303 ip_cv.fC_1);
304
305 if (!this->process_data_.apply_mass_lumping)
306 {
307 models.fC_2a_model.eval(ip_cv.biot_data,
308 pCap_data,
309 current_state.constituent_density_data,
310 ip_out.porosity_data,
311 current_state.S_L_data,
312 ip_cv.beta_p_SR,
313 ip_cv.fC_2a);
314 }
315 models.fC_3a_model.eval(dt,
316 current_state.constituent_density_data,
317 prev_state.constituent_density_data,
318 current_state.S_L_data,
319 ip_cv.fC_3a);
320
321 models.fC_4_LCpG_model.eval(ip_cv.advection_data,
322 ip_out.fluid_density_data,
323 ip_cv.phase_transition_data,
324 ip_out.porosity_data,
325 current_state.S_L_data,
326 ip_cv.fC_4_LCpG);
327
328 models.fC_4_LCpC_model.eval(ip_cv.advection_data,
329 ip_out.fluid_density_data,
330 ip_cv.phase_transition_data,
331 ip_out.porosity_data,
332 current_state.S_L_data,
333 ip_cv.fC_4_LCpC);
334
335 models.fC_4_LCT_model.eval(ip_out.fluid_density_data,
336 ip_cv.phase_transition_data,
337 ip_out.porosity_data,
338 current_state.S_L_data,
339 ip_cv.fC_4_LCT);
340
341 models.fC_4_MCpG_model.eval(ip_cv.biot_data,
342 current_state.constituent_density_data,
343 ip_out.porosity_data,
344 current_state.S_L_data,
345 ip_cv.beta_p_SR,
346 ip_cv.fC_4_MCpG);
347
348 models.fC_4_MCpC_model.eval(ip_cv.biot_data,
349 pCap_data,
350 current_state.constituent_density_data,
351 ip_out.porosity_data,
352 prev_state.S_L_data,
353 current_state.S_L_data,
354 ip_cv.beta_p_SR,
355 ip_cv.fC_4_MCpC);
356
357 models.fC_4_MCT_model.eval(ip_cv.biot_data,
358 current_state.constituent_density_data,
359 ip_out.porosity_data,
360 current_state.S_L_data,
361 ip_cv.s_therm_exp_data,
362 ip_cv.fC_4_MCT);
363
364 models.fC_4_MCu_model.eval(ip_cv.biot_data,
365 current_state.constituent_density_data,
366 current_state.S_L_data,
367 ip_cv.fC_4_MCu);
368
369 models.fW_1_model.eval(ip_cv.advection_data, ip_out.fluid_density_data,
370 ip_cv.fW_1);
371
372 if (!this->process_data_.apply_mass_lumping)
373 {
374 models.fW_2_model.eval(ip_cv.biot_data,
375 pCap_data,
376 current_state.constituent_density_data,
377 ip_out.porosity_data,
378 current_state.rho_W_LR,
379 current_state.S_L_data,
380 ip_cv.beta_p_SR,
381 ip_cv.fW_2);
382 }
383 models.fW_3a_model.eval(dt,
384 current_state.constituent_density_data,
385 prev_state.constituent_density_data,
386 prev_state.rho_W_LR,
387 current_state.rho_W_LR,
388 current_state.S_L_data,
389 ip_cv.fW_3a);
390
391 models.fW_4_LWpG_model.eval(ip_cv.advection_data,
392 ip_out.fluid_density_data,
393 ip_cv.phase_transition_data,
394 ip_out.porosity_data,
395 current_state.S_L_data,
396 ip_cv.fW_4_LWpG);
397
398 models.fW_4_LWpC_model.eval(ip_cv.advection_data,
399 ip_out.fluid_density_data,
400 ip_cv.phase_transition_data,
401 ip_out.porosity_data,
402 current_state.S_L_data,
403 ip_cv.fW_4_LWpC);
404
405 models.fW_4_LWT_model.eval(ip_out.fluid_density_data,
406 ip_cv.phase_transition_data,
407 ip_out.porosity_data,
408 current_state.S_L_data,
409 ip_cv.fW_4_LWT);
410
411 models.fW_4_MWpG_model.eval(ip_cv.biot_data,
412 current_state.constituent_density_data,
413 ip_out.porosity_data,
414 current_state.rho_W_LR,
415 current_state.S_L_data,
416 ip_cv.beta_p_SR,
417 ip_cv.fW_4_MWpG);
418
419 models.fW_4_MWpC_model.eval(ip_cv.biot_data,
420 pCap_data,
421 current_state.constituent_density_data,
422 ip_out.porosity_data,
423 prev_state.S_L_data,
424 current_state.rho_W_LR,
425 current_state.S_L_data,
426 ip_cv.beta_p_SR,
427 ip_cv.fW_4_MWpC);
428
429 models.fW_4_MWT_model.eval(ip_cv.biot_data,
430 current_state.constituent_density_data,
431 ip_out.porosity_data,
432 current_state.rho_W_LR,
433 current_state.S_L_data,
434 ip_cv.s_therm_exp_data,
435 ip_cv.fW_4_MWT);
436
437 models.fW_4_MWu_model.eval(ip_cv.biot_data,
438 current_state.constituent_density_data,
439 current_state.rho_W_LR,
440 current_state.S_L_data,
441 ip_cv.fW_4_MWu);
442
443 models.fT_1_model.eval(dt,
444 current_state.internal_energy_data,
445 prev_state.internal_energy_data,
446 ip_cv.fT_1);
447
448 // ---------------------------------------------------------------------
449 // Derivatives for Jacobian
450 // ---------------------------------------------------------------------
451
452 models.darcy_velocity_model.eval(
453 grad_p_cap,
454 ip_out.fluid_density_data,
455 grad_p_GR,
456 ip_out.permeability_data,
458 this->process_data_.specific_body_force},
459 ip_cv.viscosity_data,
460 ip_out.darcy_velocity_data);
461
462 models.fT_2_model.eval(ip_out.darcy_velocity_data,
463 ip_out.fluid_density_data,
464 ip_out.fluid_enthalpy_data,
465 ip_cv.fT_2);
466
467 models.fT_3_model.eval(
468 current_state.constituent_density_data,
469 ip_out.darcy_velocity_data,
470 ip_out.diffusion_velocity_data,
471 ip_out.fluid_density_data,
472 ip_cv.phase_transition_data,
474 this->process_data_.specific_body_force},
475 ip_cv.fT_3);
476
477 models.fu_2_KupC_model.eval(ip_cv.biot_data, ip_cv.chi_S_L,
478 ip_cv.fu_2_KupC);
479 }
480
481 return {ip_constitutive_data, ip_constitutive_variables};
482}
BaseLib::StrongType< double, struct GasPressureTag > GasPressureData
Definition Base.h:59
BaseLib::StrongType< GlobalDimVector< DisplacementDim >, struct GasPressureGradientTag > GasPressureGradientData
Definition Base.h:63
BaseLib::StrongType< GlobalDimVector< DisplacementDim >, struct TemperatureGradientTag > TemperatureGradientData
Definition Base.h:71
BaseLib::StrongType< double, struct CapillaryPressureTag > CapillaryPressureData
Definition Base.h:60
BaseLib::StrongType< GlobalDimVector< DisplacementDim >, struct CapillaryPressureGradientTag > CapillaryPressureGradientData
Definition Base.h:67
BaseLib::StrongType< double, struct ReferenceTemperatureTag > ReferenceTemperatureData
Definition Base.h:57
BaseLib::StrongType< GlobalDimVector< DisplacementDim >, struct SpecificBodyForceTag > SpecificBodyForceData
Definition Base.h:76

References ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::advection_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::beta_p_SR_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::biot_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::chi_S_L_model, ProcessLib::LinearBMatrix::computeBMatrix(), ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::darcy_velocity_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::diffusion_velocity_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::effective_volumetric_enthalpy_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::elastic_tangent_stiffness_model, ProcessLib::TH2M::ConstitutiveRelations::BiotModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::BishopsModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::EffectiveVolumetricEnthalpyModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FC2aModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FC3aModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FC4MCpCModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FC4MCpGModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FC4MCuModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FT1Model::eval(), ProcessLib::TH2M::ConstitutiveRelations::FW2Model::eval(), ProcessLib::TH2M::ConstitutiveRelations::FW3aModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FW4MWpCModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FW4MWpGModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::FW4MWuModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::InternalEnergyModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::PhaseTransitionModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::PorosityModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::PureLiquidDensityModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::SaturationModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::SolidDensityModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::SolidEnthalpyModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::SolidHeatCapacityModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::ViscosityModel::eval(), ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_1_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_2a_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_3a_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_LCpC_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_LCpG_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_LCT_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_MCpC_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_MCpG_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_MCT_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_MCu_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fT_1_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_1_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_2_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_3a_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_LWpC_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_LWpG_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_LWT_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_MWpC_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_MWpG_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_MWT_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_MWu_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::gravity_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::internal_energy_model, NumLib::interpolateCoordinates(), NumLib::interpolateXCoordinate(), ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::mechanical_strain_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::permeability_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::phase_transition_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::porosity_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::pure_liquid_density_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::S_L_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::s_mech_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::s_therm_exp_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::solid_density_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::solid_enthalpy_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::solid_heat_capacity_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::swelling_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::thermal_conductivity_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::total_stress_model, and ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::viscosity_model.

◆ updateConstitutiveVariablesDerivatives()

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
std::vector< ConstitutiveRelations::DerivativesData< DisplacementDim > > ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::updateConstitutiveVariablesDerivatives ( Eigen::VectorXd const & local_x,
Eigen::VectorXd const & local_x_prev,
double const t,
double const dt,
std::vector< ConstitutiveRelations::ConstitutiveData< DisplacementDim > > const & ip_constitutive_data,
std::vector< ConstitutiveRelations::ConstitutiveTempData< DisplacementDim > > const & ip_constitutive_variables,
ConstitutiveRelations::ConstitutiveModels< DisplacementDim > const & models )
private

Definition at line 488 of file TH2MFEM-impl.h.

500{
501 [[maybe_unused]] auto const matrix_size =
504
505 assert(local_x.size() == matrix_size);
506
507 auto const temperature =
508 local_x.template segment<temperature_size>(temperature_index);
509 auto const temperature_prev =
510 local_x_prev.template segment<temperature_size>(temperature_index);
511
512 auto const capillary_pressure =
513 local_x.template segment<capillary_pressure_size>(
515
516 auto const& medium =
517 *this->process_data_.media_map.getMedium(this->element_.getID());
518 ConstitutiveRelations::MediaData media_data{medium};
519
520 unsigned const n_integration_points =
522
523 std::vector<ConstitutiveRelations::DerivativesData<DisplacementDim>>
524 ip_d_data(n_integration_points);
525
526 for (unsigned ip = 0; ip < n_integration_points; ip++)
527 {
528 auto const& ip_data = _ip_data[ip];
529 auto& ip_dd = ip_d_data[ip];
530 auto const& ip_cd = ip_constitutive_data[ip];
531 auto const& ip_cv = ip_constitutive_variables[ip];
532 auto const& ip_out = this->output_data_[ip];
533 auto const& current_state = this->current_states_[ip];
534 auto const& prev_state = this->prev_states_[ip];
535
536 auto const& Nu = ip_data.N_u;
537 auto const& Np = ip_data.N_p;
538 auto const& NT = Np;
539
541 std::nullopt, this->element_.getID(),
543 NumLib::interpolateCoordinates<ShapeFunctionDisplacement,
545 this->element_, Nu))};
546
547 double const T = NT.dot(temperature);
548 double const T_prev = NT.dot(temperature_prev);
549 ConstitutiveRelations::TemperatureData const T_data{T, T_prev};
551 Np.dot(capillary_pressure)};
552
553 models.S_L_model.dEval({pos, t, dt}, media_data, pCap_data,
554 ip_dd.dS_L_dp_cap);
555
556 models.advection_model.dEval(current_state.constituent_density_data,
557 ip_out.permeability_data,
558 ip_cv.viscosity_data,
559 ip_dd.dS_L_dp_cap,
560 ip_cv.phase_transition_data,
561 ip_dd.advection_d_data);
562
563 models.porosity_model.dEval(
564 {pos, t, dt}, media_data, ip_out.porosity_data, ip_dd.dS_L_dp_cap,
565#ifdef NON_CONSTANT_SOLID_PHASE_VOLUME_FRACTION
566 ip_cv.biot_data, ip_out.eps_data, ip_cv.s_therm_exp_data,
567#endif // NON_CONSTANT_SOLID_PHASE_VOLUME_FRACTION
568 ip_dd.porosity_d_data);
569
570 models.thermal_conductivity_model.dEval(
571 {pos, t, dt}, media_data, T_data, ip_out.porosity_data,
572 ip_dd.porosity_d_data, current_state.S_L_data,
573 ip_dd.thermal_conductivity_d_data);
574
575 models.solid_density_model.dEval({pos, t, dt}, media_data, T_data,
576#ifdef NON_CONSTANT_SOLID_PHASE_VOLUME_FRACTION
577 ip_cv.biot_data, ip_out.eps_data,
578 ip_cv.s_therm_exp_data,
579#endif // NON_CONSTANT_SOLID_PHASE_VOLUME_FRACTION
580 ip_dd.solid_density_d_data);
581
582 models.internal_energy_model.dEval(
583 ip_out.fluid_density_data,
584 ip_cv.phase_transition_data,
585 ip_out.porosity_data,
586 ip_dd.porosity_d_data,
587 current_state.S_L_data,
588 ip_out.solid_density_data,
589 ip_dd.solid_density_d_data,
590 ip_out.solid_enthalpy_data,
591 ip_cv.solid_heat_capacity_data,
592 ip_dd.effective_volumetric_internal_energy_d_data);
593
594 models.effective_volumetric_enthalpy_model.dEval(
595 ip_out.fluid_density_data,
596 ip_out.fluid_enthalpy_data,
597 ip_cv.phase_transition_data,
598 ip_out.porosity_data,
599 ip_dd.porosity_d_data,
600 current_state.S_L_data,
601 ip_out.solid_density_data,
602 ip_dd.solid_density_d_data,
603 ip_out.solid_enthalpy_data,
604 ip_cv.solid_heat_capacity_data,
605 ip_dd.effective_volumetric_enthalpy_d_data);
606 if (!this->process_data_.apply_mass_lumping)
607 {
608 models.fC_2a_model.dEval(ip_cv.biot_data,
609 pCap_data,
610 current_state.constituent_density_data,
611 ip_cv.phase_transition_data,
612 ip_out.porosity_data,
613 ip_dd.porosity_d_data,
614 current_state.S_L_data,
615 ip_dd.dS_L_dp_cap,
616 ip_cv.beta_p_SR,
617 ip_dd.dfC_2a);
618 }
619 models.fC_3a_model.dEval(dt,
620 current_state.constituent_density_data,
621 prev_state.constituent_density_data,
622 ip_cv.phase_transition_data,
623 current_state.S_L_data,
624 ip_dd.dS_L_dp_cap,
625 ip_dd.dfC_3a);
626
627 models.fC_4_LCpG_model.dEval(ip_out.permeability_data,
628 ip_cv.viscosity_data,
629 ip_cv.phase_transition_data,
630 ip_dd.advection_d_data,
631 ip_dd.dfC_4_LCpG);
632
633 models.fC_4_LCpC_model.dEval(current_state.constituent_density_data,
634 ip_out.permeability_data,
635 ip_cv.phase_transition_data,
636 ip_dd.dS_L_dp_cap,
637 ip_cv.viscosity_data,
638 ip_dd.dfC_4_LCpC);
639
640 models.fC_4_MCpG_model.dEval(ip_cv.biot_data,
641 current_state.constituent_density_data,
642 ip_cv.phase_transition_data,
643 ip_out.porosity_data,
644 ip_dd.porosity_d_data,
645 current_state.S_L_data,
646 ip_cv.beta_p_SR,
647 ip_dd.dfC_4_MCpG);
648
649 models.fC_4_MCT_model.dEval(ip_cv.biot_data,
650 current_state.constituent_density_data,
651 ip_cv.phase_transition_data,
652 ip_out.porosity_data,
653 ip_dd.porosity_d_data,
654 current_state.S_L_data,
655 ip_cv.s_therm_exp_data,
656 ip_dd.dfC_4_MCT);
657
658 models.fC_4_MCu_model.dEval(ip_cv.biot_data,
659 ip_cv.phase_transition_data,
660 current_state.S_L_data,
661 ip_dd.dfC_4_MCu);
662
663 if (!this->process_data_.apply_mass_lumping)
664 {
665 models.fW_2_model.dEval(ip_cv.biot_data,
666 pCap_data,
667 current_state.constituent_density_data,
668 ip_cv.phase_transition_data,
669 ip_out.porosity_data,
670 ip_dd.porosity_d_data,
671 current_state.rho_W_LR,
672 current_state.S_L_data,
673 ip_dd.dS_L_dp_cap,
674 ip_cv.beta_p_SR,
675 ip_dd.dfW_2);
676 }
677
678 models.fW_3a_model.dEval(dt,
679 current_state.constituent_density_data,
680 ip_cv.phase_transition_data,
681 prev_state.constituent_density_data,
682 prev_state.rho_W_LR,
683 current_state.rho_W_LR,
684 current_state.S_L_data,
685 ip_dd.dS_L_dp_cap,
686 ip_dd.dfW_3a);
687
688 models.fW_4_LWpG_model.dEval(current_state.constituent_density_data,
689 ip_out.permeability_data,
690 ip_cv.phase_transition_data,
691 current_state.rho_W_LR,
692 ip_dd.dS_L_dp_cap,
693 ip_cv.viscosity_data,
694 ip_dd.dfW_4_LWpG);
695
696 models.fW_4_LWpC_model.dEval(ip_cv.advection_data,
697 ip_out.fluid_density_data,
698 ip_out.permeability_data,
699 ip_cv.phase_transition_data,
700 ip_out.porosity_data,
701 current_state.rho_W_LR,
702 current_state.S_L_data,
703 ip_dd.dS_L_dp_cap,
704 ip_cv.viscosity_data,
705 ip_dd.dfW_4_LWpC);
706
707 models.fT_1_model.dEval(
708 dt, ip_dd.effective_volumetric_internal_energy_d_data, ip_dd.dfT_1);
709
710 models.fT_2_model.dEval(
711 ip_out.darcy_velocity_data,
712 ip_out.fluid_density_data,
713 ip_out.fluid_enthalpy_data,
714 ip_out.permeability_data,
715 ip_cv.phase_transition_data,
717 this->process_data_.specific_body_force},
718 ip_cv.viscosity_data,
719 ip_dd.dfT_2);
720
721 models.fu_1_KuT_model.dEval(ip_cd.s_mech_data, ip_cv.s_therm_exp_data,
722 ip_dd.dfu_1_KuT);
723
724 models.fu_2_KupC_model.dEval(ip_cv.biot_data,
725 ip_cv.chi_S_L,
726 pCap_data,
727 ip_dd.dS_L_dp_cap,
728 ip_dd.dfu_2_KupC);
729 }
730
731 return ip_d_data;
732}

References ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::advection_model, ProcessLib::TH2M::ConstitutiveRelations::EffectiveVolumetricEnthalpyModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::FC2aModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::FC3aModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::FC4MCpGModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::FC4MCuModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::FT1Model::dEval(), ProcessLib::TH2M::ConstitutiveRelations::FU2KUpCModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::FW2Model::dEval(), ProcessLib::TH2M::ConstitutiveRelations::FW3aModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::InternalEnergyModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::PorosityModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::SaturationModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::SolidDensityModel::dEval(), ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::effective_volumetric_enthalpy_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_2a_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_3a_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_LCpC_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_LCpG_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_MCpG_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_MCT_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fC_4_MCu_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fT_1_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fT_2_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fu_1_KuT_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fu_2_KupC_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_2_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_3a_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_LWpC_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::fW_4_LWpG_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::internal_energy_model, NumLib::interpolateCoordinates(), ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::porosity_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::S_L_model, ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::solid_density_model, and ProcessLib::TH2M::ConstitutiveRelations::ConstitutiveModels< DisplacementDim >::thermal_conductivity_model.

Member Data Documentation

◆ _ip_data

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
std::vector<IpData> ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::_ip_data
private

◆ _secondary_data

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
SecondaryData< typename ShapeMatricesTypeDisplacement::ShapeMatrices::ShapeType> ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::_secondary_data
private

◆ C_index

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::C_index = 0
staticprivate

Definition at line 242 of file TH2MFEM.h.

◆ C_size

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::C_size = ShapeFunctionPressure::NPOINTS
staticprivate

Definition at line 243 of file TH2MFEM.h.

◆ capillary_pressure_index

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::capillary_pressure_index = ShapeFunctionPressure::NPOINTS
staticprivate

Definition at line 234 of file TH2MFEM.h.

◆ capillary_pressure_size

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::capillary_pressure_size = ShapeFunctionPressure::NPOINTS
staticprivate

Definition at line 235 of file TH2MFEM.h.

◆ displacement_index

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::displacement_index = ShapeFunctionPressure::NPOINTS * 3
staticprivate

◆ displacement_size

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::displacement_size
staticprivate
Initial value:
=
ShapeFunctionDisplacement::NPOINTS * DisplacementDim

Definition at line 239 of file TH2MFEM.h.

Referenced by ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::getVectorDeformationSegment().

◆ gas_pressure_index

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::gas_pressure_index = 0
staticprivate

Definition at line 232 of file TH2MFEM.h.

◆ gas_pressure_size

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::gas_pressure_size = ShapeFunctionPressure::NPOINTS
staticprivate

Definition at line 233 of file TH2MFEM.h.

◆ KelvinVectorSize

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
int const ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::KelvinVectorSize
static
Initial value:
=
constexpr int kelvin_vector_dimensions(int const displacement_dim)
Kelvin vector dimensions for given displacement dimension.

Definition at line 71 of file TH2MFEM.h.

◆ N_u_op

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
auto& ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::N_u_op
staticconstexpr
Initial value:
DisplacementDim,
constexpr Eigen::CwiseNullaryOp< EigenBlockMatrixViewFunctor< D, M >, typename EigenBlockMatrixViewFunctor< D, M >::Matrix > eigenBlockMatrixView(const Eigen::MatrixBase< M > &matrix)
RowVectorType< ShapeFunction::NPOINTS > NodalRowVectorType

Definition at line 75 of file TH2MFEM.h.

◆ temperature_index

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::temperature_index = 2 * ShapeFunctionPressure::NPOINTS
staticprivate

Definition at line 236 of file TH2MFEM.h.

◆ temperature_size

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::temperature_size = ShapeFunctionPressure::NPOINTS
staticprivate

Definition at line 237 of file TH2MFEM.h.

◆ W_index

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::W_index = ShapeFunctionPressure::NPOINTS
staticprivate

Definition at line 244 of file TH2MFEM.h.

◆ W_size

template<typename ShapeFunctionDisplacement , typename ShapeFunctionPressure , int DisplacementDim>
const int ProcessLib::TH2M::TH2MLocalAssembler< ShapeFunctionDisplacement, ShapeFunctionPressure, DisplacementDim >::W_size = ShapeFunctionPressure::NPOINTS
staticprivate

Definition at line 245 of file TH2MFEM.h.


The documentation for this class was generated from the following files: