OGS
ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim > Class Template Referencefinal

Detailed Description

template<int DisplacementDim>
class ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >

Definition at line 26 of file HydroMechanicsProcess.h.

#include <HydroMechanicsProcess.h>

Inheritance diagram for ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >:
[legend]
Collaboration diagram for ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >:
[legend]

Public Member Functions

 HydroMechanicsProcess (std::string name, MeshLib::Mesh &mesh, std::unique_ptr< ProcessLib::AbstractJacobianAssembler > &&jacobian_assembler, std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const &parameters, unsigned const integration_order, std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > &&process_variables, HydroMechanicsProcessData< DisplacementDim > &&process_data, SecondaryVariableCollection &&secondary_variables, bool const use_monolithic_scheme)
 
void postTimestepConcreteProcess (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, double const t, double const dt, int const process_id) override
 
ODESystem interface
bool isLinear () const override
 
- Public Member Functions inherited from ProcessLib::Process
 Process (std::string name_, MeshLib::Mesh &mesh, std::unique_ptr< AbstractJacobianAssembler > &&jacobian_assembler, std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const &parameters, unsigned const integration_order, std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > &&process_variables, SecondaryVariableCollection &&secondary_variables, const bool use_monolithic_scheme=true)
 
void preTimestep (std::vector< GlobalVector * > const &x, const double t, const double delta_t, const int process_id)
 Preprocessing before starting assembly for new timestep.
 
void postTimestep (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, const double t, const double delta_t, int const process_id)
 Postprocessing after a complete timestep.
 
void postNonLinearSolver (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, const double t, double const dt, int const process_id)
 
void preIteration (const unsigned iter, GlobalVector const &x) final
 
void computeSecondaryVariable (double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_prev, int const process_id)
 compute secondary variables for the coupled equations or for output.
 
NumLib::IterationResult postIteration (GlobalVector const &x) final
 
void initialize (std::map< int, std::shared_ptr< MaterialPropertyLib::Medium > > const &media)
 
void setInitialConditions (std::vector< GlobalVector * > &process_solutions, std::vector< GlobalVector * > const &process_solutions_prev, double const t, int const process_id)
 
MathLib::MatrixSpecifications getMatrixSpecifications (const int process_id) const override
 
void updateDeactivatedSubdomains (double const time, const int process_id)
 
virtual bool isMonolithicSchemeUsed () const
 
virtual void extrapolateIntegrationPointValuesToNodes (const double, std::vector< GlobalVector * > const &, std::vector< GlobalVector * > &)
 
void preAssemble (const double t, double const dt, GlobalVector const &x) final
 
void assemble (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b) final
 
void assembleWithJacobian (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalVector &b, GlobalMatrix &Jac) final
 
void preOutput (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id)
 
std::vector< NumLib::IndexValueVector< GlobalIndexType > > const * getKnownSolutions (double const t, GlobalVector const &x, int const process_id) const final
 
virtual NumLib::LocalToGlobalIndexMap const & getDOFTable (const int) const
 
MeshLib::MeshgetMesh () const
 
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > const & getProcessVariables () const
 
std::vector< std::reference_wrapper< ProcessVariable > > const & getProcessVariables (const int process_id) const
 
std::vector< std::size_t > const & getActiveElementIDs () const
 
SecondaryVariableCollection const & getSecondaryVariables () const
 
std::vector< std::unique_ptr< MeshLib::IntegrationPointWriter > > const & getIntegrationPointWriters () const
 
virtual Eigen::Vector3d getFlux (std::size_t, MathLib::Point3d const &, double const, std::vector< GlobalVector * > const &) const
 
virtual void solveReactionEquation (std::vector< GlobalVector * > &, std::vector< GlobalVector * > const &, double const, double const, NumLib::EquationSystem &, int const)
 
bool requiresNormalization () const override
 
- Public Member Functions inherited from ProcessLib::SubmeshAssemblySupport
virtual std::vector< std::vector< std::string > > initializeAssemblyOnSubmeshes (std::vector< std::reference_wrapper< MeshLib::Mesh > > const &meshes)
 
virtual ~SubmeshAssemblySupport ()=default
 

Private Types

using LocalAssemblerInterface = HydroMechanicsLocalAssemblerInterface
 

Private Member Functions

void constructDofTable () override
 
void initializeConcreteProcess (NumLib::LocalToGlobalIndexMap const &dof_table, MeshLib::Mesh const &mesh, unsigned const integration_order) override
 Process specific initialization called by initialize().
 
void assembleConcreteProcess (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b) override
 
void assembleWithJacobianConcreteProcess (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalVector &b, GlobalMatrix &Jac) override
 
void preTimestepConcreteProcess (std::vector< GlobalVector * > const &x, double const t, double const dt, int const process_id) override
 
void updateElementLevelSets (MeshLib::Element const &e, MeshLib::Mesh &mesh)
 

Private Attributes

HydroMechanicsProcessData< DisplacementDim > _process_data
 
std::vector< std::unique_ptr< LocalAssemblerInterface > > _local_assemblers
 
std::vector< MeshLib::Element * > _vec_matrix_elements
 
std::vector< int > _vec_fracture_mat_IDs
 
std::vector< std::vector< MeshLib::Element * > > _vec_fracture_elements
 
std::vector< std::vector< MeshLib::Element * > > _vec_fracture_matrix_elements
 
std::vector< std::vector< MeshLib::Node * > > _vec_fracture_nodes
 
std::vector< MeshLib::Node * > _vec_junction_nodes
 
std::vector< std::vector< MeshLib::Element * > > _vec_junction_fracture_matrix_elements
 
std::vector< std::unique_ptr< MeshLib::MeshSubset const > > _mesh_subset_fracture_nodes
 
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_junction_nodes
 
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_matrix_nodes
 
std::vector< MeshLib::Node * > _mesh_nodes_p
 
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_nodes_p
 

Additional Inherited Members

- Public Attributes inherited from ProcessLib::Process
std::string const name
 
- Static Public Attributes inherited from ProcessLib::Process
static PROCESSLIB_EXPORT const std::string constant_one_parameter_name = "constant_one"
 
- Protected Member Functions inherited from ProcessLib::Process
std::vector< NumLib::LocalToGlobalIndexMap const * > getDOFTables (int const number_of_processes) const
 
NumLib::ExtrapolatorgetExtrapolator () const
 
NumLib::LocalToGlobalIndexMap const & getSingleComponentDOFTable () const
 
void initializeProcessBoundaryConditionsAndSourceTerms (const NumLib::LocalToGlobalIndexMap &dof_table, const int process_id, std::map< int, std::shared_ptr< MaterialPropertyLib::Medium > > const &media)
 
void constructMonolithicProcessDofTable ()
 
void constructDofTableOfSpecifiedProcessStaggeredScheme (const int specified_process_id)
 
virtual std::tuple< NumLib::LocalToGlobalIndexMap *, bool > getDOFTableForExtrapolatorData () const
 
std::vector< GlobalIndexTypegetIndicesOfResiduumWithoutInitialCompensation () const override
 
- Protected Attributes inherited from ProcessLib::Process
MeshLib::Mesh_mesh
 
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_all_nodes
 
std::unique_ptr< NumLib::LocalToGlobalIndexMap_local_to_global_index_map
 
SecondaryVariableCollection _secondary_variables
 
CellAverageData cell_average_data_
 
std::unique_ptr< ProcessLib::AbstractJacobianAssembler_jacobian_assembler
 
VectorMatrixAssembler _global_assembler
 
const bool _use_monolithic_scheme
 
unsigned const _integration_order
 
std::vector< std::unique_ptr< MeshLib::IntegrationPointWriter > > _integration_point_writer
 
GlobalSparsityPattern _sparsity_pattern
 
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > _process_variables
 
std::vector< BoundaryConditionCollection_boundary_conditions
 

Member Typedef Documentation

◆ LocalAssemblerInterface

template<int DisplacementDim>
using ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::LocalAssemblerInterface = HydroMechanicsLocalAssemblerInterface
private

Definition at line 58 of file HydroMechanicsProcess.h.

Constructor & Destructor Documentation

◆ HydroMechanicsProcess()

template<int DisplacementDim>
ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::HydroMechanicsProcess ( std::string name,
MeshLib::Mesh & mesh,
std::unique_ptr< ProcessLib::AbstractJacobianAssembler > && jacobian_assembler,
std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const & parameters,
unsigned const integration_order,
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > && process_variables,
HydroMechanicsProcessData< DisplacementDim > && process_data,
SecondaryVariableCollection && secondary_variables,
bool const use_monolithic_scheme )

Definition at line 40 of file HydroMechanicsProcess.cpp.

51 : Process(std::move(name), mesh, std::move(jacobian_assembler), parameters,
52 integration_order, std::move(process_variables),
53 std::move(secondary_variables), use_monolithic_scheme),
54 _process_data(std::move(process_data))
55{
56 INFO("[LIE/HM] looking for fracture elements in the given mesh");
57 std::vector<std::pair<std::size_t, std::vector<int>>>
58 vec_branch_nodeID_matIDs;
59 std::vector<std::pair<std::size_t, std::vector<int>>>
60 vec_junction_nodeID_matIDs;
64 _vec_fracture_nodes, vec_branch_nodeID_matIDs,
65 vec_junction_nodeID_matIDs);
66
67 if (_vec_fracture_mat_IDs.size() !=
68 _process_data.fracture_properties.size())
69 {
71 "The number of the given fracture properties ({:d}) are not "
72 "consistent with the number of fracture groups in a mesh ({:d}).",
73 _process_data.fracture_properties.size(),
75 }
76
77 // create a map from a material ID to a fracture ID
78 auto max_frac_mat_id = std::max_element(_vec_fracture_mat_IDs.begin(),
80 _process_data.map_materialID_to_fractureID.resize(*max_frac_mat_id + 1);
81 for (unsigned i = 0; i < _vec_fracture_mat_IDs.size(); i++)
82 {
83 _process_data.map_materialID_to_fractureID[_vec_fracture_mat_IDs[i]] =
84 i;
85 }
86
87 // create a table of connected fracture IDs for each element
88 _process_data.vec_ele_connected_fractureIDs.resize(
89 mesh.getNumberOfElements());
90 for (unsigned i = 0; i < _vec_fracture_matrix_elements.size(); i++)
91 {
92 for (auto e : _vec_fracture_matrix_elements[i])
93 {
94 _process_data.vec_ele_connected_fractureIDs[e->getID()].push_back(
95 i);
96 }
97 }
98
99 // set fracture property
100 for (auto& fracture_prop : _process_data.fracture_properties)
101 {
102 // based on the 1st element assuming a fracture forms a straight line
104 DisplacementDim,
105 *_vec_fracture_elements[fracture_prop.fracture_id][0],
106 fracture_prop);
107 }
108
109 // set branches
110 for (auto const& [vec_branch_nodeID, matID] : vec_branch_nodeID_matIDs)
111 {
112 auto const master_matId = matID[0];
113 auto const slave_matId = matID[1];
114 auto& master_frac =
115 _process_data.fracture_properties
116 [_process_data.map_materialID_to_fractureID[master_matId]];
117 auto& slave_frac =
118 _process_data.fracture_properties
119 [_process_data.map_materialID_to_fractureID[slave_matId]];
120
121 master_frac.branches_master.push_back(createBranchProperty(
122 *mesh.getNode(vec_branch_nodeID), master_frac, slave_frac));
123
124 slave_frac.branches_slave.push_back(createBranchProperty(
125 *mesh.getNode(vec_branch_nodeID), master_frac, slave_frac));
126 }
127
128 // set junctions
129 transform(cbegin(vec_junction_nodeID_matIDs),
130 cend(vec_junction_nodeID_matIDs),
131 back_inserter(_vec_junction_nodes),
132 [&](auto& vec_junction_nodeID_matID)
133 {
134 return const_cast<MeshLib::Node*>(
135 _mesh.getNode(vec_junction_nodeID_matID.first));
136 });
137
138 for (std::size_t i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
139 {
140 auto const& material_ids = vec_junction_nodeID_matIDs[i].second;
141 assert(material_ids.size() == 2);
142 std::array<int, 2> fracture_ids{
143 {_process_data.map_materialID_to_fractureID[material_ids[0]],
144 _process_data.map_materialID_to_fractureID[material_ids[1]]}};
145
146 _process_data.junction_properties.emplace_back(
147 i, *mesh.getNode(vec_junction_nodeID_matIDs[i].first),
148 fracture_ids);
149 }
150
151 // create a table of connected junction IDs for each element
152 _process_data.vec_ele_connected_junctionIDs.resize(
153 mesh.getNumberOfElements());
154 for (unsigned i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
155 {
156 auto node = mesh.getNode(vec_junction_nodeID_matIDs[i].first);
157 for (auto id :
159 {
160 _process_data.vec_ele_connected_junctionIDs[id].push_back(i);
161 }
162 }
163
164 // create a table of junction node and connected elements
166 vec_junction_nodeID_matIDs.size());
167 for (unsigned i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
168 {
169 auto node = mesh.getNode(vec_junction_nodeID_matIDs[i].first);
170 for (auto e : mesh.getElementsConnectedToNode(*node))
171 {
173 const_cast<MeshLib::Element*>(e));
174 }
175 }
176
177 //
178 // If Neumann BCs for the displacement_jump variable are required they need
179 // special treatment because of the levelset function. The implementation
180 // exists in the version 6.1.0 (e54815cc07ee89c81f953a4955b1c788595dd725)
181 // and was removed due to lack of applications.
182 //
183
184 if (!_process_data.deactivate_matrix_in_flow)
185 {
186 _process_data.p_element_status =
187 std::make_unique<MeshLib::ElementStatus>(&mesh);
188 }
189 else
190 {
191 auto const range =
193 if (!range)
194 {
195 OGS_FATAL(
196 "Could not get minimum/maximum ranges values for the "
197 "MaterialIDs property in the mesh '{:s}'.",
198 mesh.getName());
199 }
200
201 std::vector<int> vec_p_inactive_matIDs;
202 for (int matID = range->first; matID <= range->second; matID++)
203 {
204 if (std::find(_vec_fracture_mat_IDs.begin(),
206 matID) == _vec_fracture_mat_IDs.end())
207 {
208 vec_p_inactive_matIDs.push_back(matID);
209 }
210 }
211 _process_data.p_element_status =
212 std::make_unique<MeshLib::ElementStatus>(&mesh,
213 vec_p_inactive_matIDs);
214
215 const int monolithic_process_id = 0;
216 ProcessVariable const& pv_p =
217 getProcessVariables(monolithic_process_id)[0];
218 _process_data.p0 = &pv_p.getInitialCondition();
219 }
220 MeshLib::PropertyVector<int> const* material_ids(
221 mesh.getProperties().getPropertyVector<int>("MaterialIDs"));
222 _process_data.mesh_prop_materialIDs = material_ids;
223}
#define OGS_FATAL(...)
Definition Error.h:26
void INFO(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:35
const Node * getNode(std::size_t idx) const
Get the node with the given index.
Definition Mesh.h:93
Properties & getProperties()
Definition Mesh.h:136
const std::string getName() const
Get name of the mesh.
Definition Mesh.h:105
std::vector< Element const * > const & getElementsConnectedToNode(std::size_t node_id) const
Definition Mesh.cpp:257
std::size_t getNumberOfElements() const
Get the number of elements.
Definition Mesh.h:99
PropertyVector< T > const * getPropertyVector(std::string_view name) const
static std::optional< std::pair< T, T > > const getValueBounds(MeshLib::PropertyVector< T > const &property)
std::vector< std::vector< MeshLib::Node * > > _vec_fracture_nodes
std::vector< std::vector< MeshLib::Element * > > _vec_junction_fracture_matrix_elements
std::vector< std::vector< MeshLib::Element * > > _vec_fracture_elements
HydroMechanicsProcessData< DisplacementDim > _process_data
std::vector< std::vector< MeshLib::Element * > > _vec_fracture_matrix_elements
std::string const name
Definition Process.h:362
Process(std::string name_, MeshLib::Mesh &mesh, std::unique_ptr< AbstractJacobianAssembler > &&jacobian_assembler, std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const &parameters, unsigned const integration_order, std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > &&process_variables, SecondaryVariableCollection &&secondary_variables, const bool use_monolithic_scheme=true)
Definition Process.cpp:44
MeshLib::Mesh & _mesh
Definition Process.h:365
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > const & getProcessVariables() const
Definition Process.h:156
constexpr ranges::views::view_closure ids
For an element of a range view return its id.
Definition Mesh.h:227
PropertyVector< int > const * materialIDs(Mesh const &mesh)
Definition Mesh.cpp:269
void setFractureProperty(int const dim, MeshLib::Element const &e, FractureProperty &frac_prop)
void getFractureMatrixDataInMesh(MeshLib::Mesh const &mesh, std::vector< MeshLib::Element * > &vec_matrix_elements, std::vector< int > &vec_fracture_mat_IDs, std::vector< std::vector< MeshLib::Element * > > &vec_fracture_elements, std::vector< std::vector< MeshLib::Element * > > &vec_fracture_matrix_elements, std::vector< std::vector< MeshLib::Node * > > &vec_fracture_nodes, std::vector< std::pair< std::size_t, std::vector< int > > > &vec_branch_nodeID_matIDs, std::vector< std::pair< std::size_t, std::vector< int > > > &vec_junction_nodeID_matIDs)
BranchProperty createBranchProperty(MeshLib::Node const &branchNode, FractureProperty const &master_frac, FractureProperty const &slave_frac)

References ProcessLib::Process::_mesh, ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_process_data, ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_fracture_elements, ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_fracture_mat_IDs, ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_fracture_matrix_elements, ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_fracture_nodes, ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_junction_fracture_matrix_elements, ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_junction_nodes, ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_matrix_elements, ProcessLib::LIE::createBranchProperty(), MeshLib::Mesh::getElementsConnectedToNode(), ProcessLib::LIE::getFractureMatrixDataInMesh(), ProcessLib::ProcessVariable::getInitialCondition(), MeshLib::Mesh::getName(), MeshLib::Mesh::getNode(), MeshLib::Mesh::getNumberOfElements(), ProcessLib::Process::getProcessVariables(), MeshLib::Mesh::getProperties(), MeshLib::Properties::getPropertyVector(), MeshToolsLib::MeshInformation::getValueBounds(), MeshLib::views::ids, INFO(), OGS_FATAL, and ProcessLib::LIE::setFractureProperty().

Member Function Documentation

◆ assembleConcreteProcess()

template<int DisplacementDim>
void ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::assembleConcreteProcess ( const double t,
double const dt,
std::vector< GlobalVector * > const & x,
std::vector< GlobalVector * > const & x_prev,
int const process_id,
GlobalMatrix & M,
GlobalMatrix & K,
GlobalVector & b )
overrideprivatevirtual

Implements ProcessLib::Process.

Definition at line 590 of file HydroMechanicsProcess.cpp.

594{
595 DBUG("Assemble HydroMechanicsProcess.");
596
597 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_table = {
599 // Call global assembler for each local assembly item.
602 dof_table, t, dt, x, x_prev, process_id, &M, &K, &b);
603}
void DBUG(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:30
std::vector< std::unique_ptr< LocalAssemblerInterface > > _local_assemblers
VectorMatrixAssembler _global_assembler
Definition Process.h:377
std::unique_ptr< NumLib::LocalToGlobalIndexMap > _local_to_global_index_map
Definition Process.h:368
void assemble(std::size_t const mesh_item_id, LocalAssemblerInterface &local_assembler, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, double const t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalMatrix *M, GlobalMatrix *K, GlobalVector *b)
static void executeMemberDereferenced(Object &object, Method method, Container const &container, Args &&... args)

References ProcessLib::VectorMatrixAssembler::assemble(), DBUG(), and NumLib::SerialExecutor::executeMemberDereferenced().

◆ assembleWithJacobianConcreteProcess()

template<int DisplacementDim>
void ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::assembleWithJacobianConcreteProcess ( const double t,
double const dt,
std::vector< GlobalVector * > const & x,
std::vector< GlobalVector * > const & x_prev,
int const process_id,
GlobalVector & b,
GlobalMatrix & Jac )
overrideprivatevirtual

Implements ProcessLib::Process.

Definition at line 606 of file HydroMechanicsProcess.cpp.

611{
612 DBUG("AssembleWithJacobian HydroMechanicsProcess.");
613
614 // Call global assembler for each local assembly item.
615 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_table = {
619 _local_assemblers, getActiveElementIDs(), dof_table, t, dt, x, x_prev,
620 process_id, &b, &Jac);
621
622 auto copyRhs = [&](int const variable_id, auto& output_vector)
623 {
626 output_vector, std::negate<double>());
627 };
628 copyRhs(0, *_process_data.mesh_prop_hydraulic_flow);
629 copyRhs(1, *_process_data.mesh_prop_nodal_forces);
630 copyRhs(2, *_process_data.mesh_prop_nodal_forces_jump);
631}
std::vector< std::size_t > const & getActiveElementIDs() const
Definition Process.h:167
void assembleWithJacobian(std::size_t const mesh_item_id, LocalAssemblerInterface &local_assembler, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalVector *b, GlobalMatrix *Jac)
void transformVariableFromGlobalVector(GlobalVector const &input_vector, int const variable_id, NumLib::LocalToGlobalIndexMap const &local_to_global_index_map, MeshLib::PropertyVector< double > &output_vector, Functor map_function)
static void executeSelectedMemberDereferenced(Object &object, Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References ProcessLib::VectorMatrixAssembler::assembleWithJacobian(), DBUG(), and NumLib::SerialExecutor::executeSelectedMemberDereferenced().

◆ constructDofTable()

template<int DisplacementDim>
void ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::constructDofTable ( )
overrideprivatevirtual

This function is for general cases, in which all equations of the coupled processes have the same number of unknowns. For the general cases with the staggered scheme, all equations of the coupled processes share one DOF table hold by _local_to_global_index_map. Other cases can be considered by overloading this member function in the derived class.

Reimplemented from ProcessLib::Process.

Definition at line 226 of file HydroMechanicsProcess.cpp.

227{
228 //------------------------------------------------------------
229 // prepare mesh subsets to define DoFs
230 //------------------------------------------------------------
231 // for extrapolation
233 std::make_unique<MeshLib::MeshSubset>(_mesh, _mesh.getNodes());
234 // pressure
236 _process_data.p_element_status->getActiveElements());
238 std::make_unique<MeshLib::MeshSubset>(_mesh, _mesh_nodes_p);
239 // regular u
241 std::make_unique<MeshLib::MeshSubset>(_mesh, _mesh.getNodes());
242 // u jump
243 for (unsigned i = 0; i < _vec_fracture_nodes.size(); i++)
244 {
246 std::make_unique<MeshLib::MeshSubset const>(
248 }
249 // enrichment for junctions
251 std::make_unique<MeshLib::MeshSubset>(_mesh, _vec_junction_nodes);
252
253 // Collect the mesh subsets in a vector. (pressure, displacement,
254 // displacement_jump_fracture, and displacement_jump_junction)
255 std::vector<MeshLib::MeshSubset> all_mesh_subsets;
256 all_mesh_subsets.emplace_back(*_mesh_subset_nodes_p);
257 std::generate_n(std::back_inserter(all_mesh_subsets), DisplacementDim,
258 [&]() { return *_mesh_subset_matrix_nodes; });
259 for (auto const& ms : _mesh_subset_fracture_nodes)
260 {
261 std::generate_n(std::back_inserter(all_mesh_subsets),
262 DisplacementDim,
263 [&]() { return *ms; });
264 }
265 std::generate_n(std::back_inserter(all_mesh_subsets),
266 DisplacementDim,
267 [&]() { return *_mesh_subset_junction_nodes; });
268
269 // The corresponding number of components for (pressure, displacement,
270 // displacement_jump_fracture, and displacement_jump_junction).
271 std::vector<int> vec_n_components;
272 vec_n_components.push_back(1); // pressure
273 vec_n_components.insert(
274 vec_n_components.end(),
275 1 + _vec_fracture_mat_IDs.size() + _vec_junction_nodes.size(),
276 DisplacementDim); // all displacements
277
278 auto const all_fracture_matrix_elements = _vec_fracture_matrix_elements |
279 ranges::views::join |
280 ranges::to<std::vector>();
281 std::vector<std::vector<MeshLib::Element*> const*> vec_var_elements;
282 if (!_process_data.deactivate_matrix_in_flow)
283 {
284 vec_var_elements.push_back(&_mesh.getElements());
285 }
286 else
287 {
288 // TODO set elements including active nodes for pressure.
289 // cannot use ElementStatus
290 vec_var_elements.push_back(&all_fracture_matrix_elements);
291 }
292 vec_var_elements.push_back(&_vec_matrix_elements);
293 for (unsigned i = 0; i < _vec_fracture_matrix_elements.size(); i++)
294 {
295 vec_var_elements.push_back(&_vec_fracture_matrix_elements[i]);
296 }
297 for (unsigned i = 0; i < _vec_junction_fracture_matrix_elements.size(); i++)
298 {
299 vec_var_elements.push_back(&_vec_junction_fracture_matrix_elements[i]);
300 }
301
302 INFO("[LIE/HM] creating a DoF table");
304 std::make_unique<NumLib::LocalToGlobalIndexMap>(
305 std::move(all_mesh_subsets),
306 vec_n_components,
307 vec_var_elements,
309
310 DBUG("[LIE/HM] created {:d} DoF", _local_to_global_index_map->size());
311}
std::vector< Node * > const & getNodes() const
Get the nodes-vector for the mesh.
Definition Mesh.h:108
std::vector< Element * > const & getElements() const
Get the element-vector for the mesh.
Definition Mesh.h:111
std::vector< std::unique_ptr< MeshLib::MeshSubset const > > _mesh_subset_fracture_nodes
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_matrix_nodes
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_junction_nodes
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_nodes_p
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_all_nodes
Definition Process.h:366
std::vector< Node * > getBaseNodes(std::vector< Element * > const &elements)
Definition Utils.h:26
@ BY_COMPONENT
Ordering data by component type.

References NumLib::BY_COMPONENT, DBUG(), MeshLib::getBaseNodes(), and INFO().

◆ initializeConcreteProcess()

template<int DisplacementDim>
void ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::initializeConcreteProcess ( NumLib::LocalToGlobalIndexMap const & dof_table,
MeshLib::Mesh const & mesh,
unsigned const integration_order )
overrideprivatevirtual

Process specific initialization called by initialize().

Implements ProcessLib::Process.

Definition at line 362 of file HydroMechanicsProcess.cpp.

366{
367 assert(mesh.getDimension() == DisplacementDim);
368 INFO("[LIE/HM] creating local assemblers");
370 DisplacementDim, HydroMechanicsLocalAssemblerMatrix,
371 HydroMechanicsLocalAssemblerMatrixNearFracture,
372 HydroMechanicsLocalAssemblerFracture>(
373 mesh.getElements(), dof_table, _local_assemblers,
374 NumLib::IntegrationOrder{integration_order}, mesh.isAxiallySymmetric(),
376
377 auto add_secondary_variable = [&](std::string const& name,
378 int const num_components,
379 auto get_ip_values_function)
380 {
382 name,
383 makeExtrapolator(num_components, getExtrapolator(),
385 std::move(get_ip_values_function)));
386 };
387
388 add_secondary_variable("sigma",
390 DisplacementDim>::RowsAtCompileTime,
392
393 add_secondary_variable("epsilon",
395 DisplacementDim>::RowsAtCompileTime,
397
398 add_secondary_variable("velocity", DisplacementDim,
400
401 add_secondary_variable("fracture_velocity", DisplacementDim,
403
404 add_secondary_variable("fracture_stress", DisplacementDim,
406
407 add_secondary_variable("fracture_aperture", 1,
409
410 add_secondary_variable(
411 "fracture_permeability", 1,
413
415 const_cast<MeshLib::Mesh&>(mesh), "sigma_avg",
418 DisplacementDim>::RowsAtCompileTime);
419
421 const_cast<MeshLib::Mesh&>(mesh), "velocity_avg",
422 MeshLib::MeshItemType::Cell, DisplacementDim);
423
424 for (MeshLib::Element const* e : _mesh.getElements())
425 {
426 if (e->getDimension() < DisplacementDim)
427 {
428 continue;
429 }
430
431 updateElementLevelSets(*e, const_cast<MeshLib::Mesh&>(mesh));
432 }
433
434 _process_data.element_local_jumps =
436 const_cast<MeshLib::Mesh&>(mesh), "local_jump_w_avg",
437 MeshLib::MeshItemType::Cell, DisplacementDim);
438
439 _process_data.element_fracture_stresses =
441 const_cast<MeshLib::Mesh&>(mesh), "fracture_stress_avg",
442 MeshLib::MeshItemType::Cell, DisplacementDim);
443
444 _process_data.element_fracture_velocities =
446 const_cast<MeshLib::Mesh&>(mesh), "fracture_velocity_avg",
447 MeshLib::MeshItemType::Cell, DisplacementDim);
448
450 const_cast<MeshLib::Mesh&>(mesh), "fracture_aperture_avg",
452
453 mesh_prop_b->resize(mesh.getNumberOfElements());
454 auto const& mesh_prop_matid = *_process_data.mesh_prop_materialIDs;
455 for (auto const& fracture_prop : _process_data.fracture_properties)
456 {
457 for (MeshLib::Element const* e : _mesh.getElements())
458 {
459 if (e->getDimension() == DisplacementDim)
460 {
461 continue;
462 }
463 if (mesh_prop_matid[e->getID()] != fracture_prop.mat_id)
464 {
465 continue;
466 }
467 // Mean value for the element. This allows usage of node based
468 // properties for aperture.
469 (*mesh_prop_b)[e->getID()] =
470 fracture_prop.aperture0
471 .getNodalValuesOnElement(*e, /*time independent*/ 0)
472 .mean();
473 }
474 }
475
476 auto mesh_prop_k_f = MeshLib::getOrCreateMeshProperty<double>(
477 const_cast<MeshLib::Mesh&>(mesh), "fracture_permeability_avg",
479 mesh_prop_k_f->resize(mesh.getNumberOfElements());
480 _process_data.mesh_prop_k_f = mesh_prop_k_f;
481
482 auto mesh_prop_fracture_shear_failure =
484 const_cast<MeshLib::Mesh&>(mesh), "f_shear_failure",
486 mesh_prop_fracture_shear_failure->resize(mesh.getNumberOfElements());
487 _process_data.mesh_prop_fracture_shear_failure =
488 mesh_prop_fracture_shear_failure;
489
490 auto mesh_prop_nodal_p = MeshLib::getOrCreateMeshProperty<double>(
491 const_cast<MeshLib::Mesh&>(mesh), "pressure_interpolated",
493 mesh_prop_nodal_p->resize(mesh.getNumberOfNodes());
494 _process_data.mesh_prop_nodal_p = mesh_prop_nodal_p;
495
496 _process_data.mesh_prop_nodal_forces =
498 const_cast<MeshLib::Mesh&>(mesh), "NodalForces",
499 MeshLib::MeshItemType::Node, DisplacementDim);
500 assert(_process_data.mesh_prop_nodal_forces->size() ==
501 DisplacementDim * mesh.getNumberOfNodes());
502
503 _process_data.mesh_prop_nodal_forces_jump =
505 const_cast<MeshLib::Mesh&>(mesh), "NodalForcesJump",
506 MeshLib::MeshItemType::Node, DisplacementDim);
507 assert(_process_data.mesh_prop_nodal_forces_jump->size() ==
508 DisplacementDim * mesh.getNumberOfNodes());
509
510 _process_data.mesh_prop_hydraulic_flow =
512 const_cast<MeshLib::Mesh&>(mesh), "MassFlowRate",
514 assert(_process_data.mesh_prop_hydraulic_flow->size() ==
515 mesh.getNumberOfNodes());
516 _process_data.mesh_prop_b = mesh_prop_b;
517}
virtual std::vector< double > const & getIntPtFracturePermeability(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
virtual std::vector< double > const & getIntPtDarcyVelocity(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
virtual std::vector< double > const & getIntPtFractureAperture(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
virtual std::vector< double > const & getIntPtFractureStress(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
virtual std::vector< double > const & getIntPtEpsilon(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
virtual std::vector< double > const & getIntPtFractureVelocity(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
virtual std::vector< double > const & getIntPtSigma(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
void updateElementLevelSets(MeshLib::Element const &e, MeshLib::Mesh &mesh)
SecondaryVariableCollection _secondary_variables
Definition Process.h:370
NumLib::Extrapolator & getExtrapolator() const
Definition Process.h:208
void addSecondaryVariable(std::string const &internal_name, SecondaryVariableFunctions &&fcts)
Eigen::Matrix< double, kelvin_vector_dimensions(DisplacementDim), 1, Eigen::ColMajor > KelvinVectorType
PropertyVector< T > * getOrCreateMeshProperty(Mesh &mesh, std::string const &property_name, MeshItemType const item_type, int const number_of_components)
void createLocalAssemblers(std::vector< MeshLib::Element * > const &mesh_elements, NumLib::LocalToGlobalIndexMap const &dof_table, std::vector< std::unique_ptr< LocalAssemblerInterface > > &local_assemblers, NumLib::IntegrationOrder const integration_order, ExtraCtorArgs &&... extra_ctor_args)
SecondaryVariableFunctions makeExtrapolator(const unsigned num_components, NumLib::Extrapolator &extrapolator, LocalAssemblerCollection const &local_assemblers, typename NumLib::ExtrapolatableLocalAssemblerCollection< LocalAssemblerCollection >::IntegrationPointValuesMethod integration_point_values_method)

References MeshLib::Cell, ProcessLib::LIE::HydroMechanics::createLocalAssemblers(), MeshLib::Mesh::getDimension(), MeshLib::Mesh::getElements(), MeshLib::Mesh::getNumberOfElements(), MeshLib::Mesh::getNumberOfNodes(), MeshLib::getOrCreateMeshProperty(), INFO(), MeshLib::Mesh::isAxiallySymmetric(), ProcessLib::makeExtrapolator(), and MeshLib::Node.

◆ isLinear()

template<int DisplacementDim>
bool ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::isLinear ( ) const
override

Definition at line 584 of file HydroMechanicsProcess.cpp.

585{
586 return false;
587}

◆ postTimestepConcreteProcess()

template<int DisplacementDim>
void ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::postTimestepConcreteProcess ( std::vector< GlobalVector * > const & x,
std::vector< GlobalVector * > const & x_prev,
double const t,
double const dt,
int const process_id )
overridevirtual

Reimplemented from ProcessLib::Process.

Definition at line 520 of file HydroMechanicsProcess.cpp.

524{
525 if (process_id == 0)
526 {
527 DBUG("PostTimestep HydroMechanicsProcess.");
528
532 x_prev, t, dt, process_id);
533 }
534
535 DBUG("Compute the secondary variables for HydroMechanicsProcess.");
536
537 const auto& dof_table = getDOFTable(process_id);
538
539 // Copy displacement jumps in a solution vector to mesh property
540 // Remark: the copy is required because mesh properties for primary
541 // variables are set during output and are not ready yet when this function
542 // is called.
543 int g_variable_id = 0;
544 {
545 const int monolithic_process_id = 0;
546 auto const& pvs = getProcessVariables(monolithic_process_id);
547 auto const it =
548 std::find_if(pvs.begin(), pvs.end(),
549 [](ProcessVariable const& pv)
550 { return pv.getName() == "displacement_jump1"; });
551 if (it == pvs.end())
552 {
553 OGS_FATAL(
554 "Didn't find expected 'displacement_jump1' process variable.");
555 }
556 g_variable_id = static_cast<int>(std::distance(pvs.begin(), it));
557 }
558
560
561 const int monolithic_process_id = 0;
562 ProcessVariable& pv_g =
563 this->getProcessVariables(monolithic_process_id)[g_variable_id];
564 auto const num_comp = pv_g.getNumberOfGlobalComponents();
565 auto& mesh_prop_g = *MeshLib::getOrCreateMeshProperty<double>(
566 _mesh, pv_g.getName(), MeshLib::MeshItemType::Node, num_comp);
567 for (int component_id = 0; component_id < num_comp; ++component_id)
568 {
569 auto const& mesh_subset =
570 dof_table.getMeshSubset(g_variable_id, component_id);
571 for (auto const& l : MeshLib::views::meshLocations(
572 mesh_subset, MeshLib::MeshItemType::Node))
573 {
574 auto const global_index =
575 dof_table.getGlobalIndex(l, g_variable_id, component_id);
576 auto const node_id = l.item_id;
577 mesh_prop_g[node_id * num_comp + component_id] =
578 (*x[process_id])[global_index];
579 }
580 }
581}
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)
std::vector< NumLib::LocalToGlobalIndexMap const * > getDOFTables(int const number_of_processes) const
Definition Process.cpp:383
virtual NumLib::LocalToGlobalIndexMap const & getDOFTable(const int) const
Definition Process.h:147
void setLocalAccessibleVector(PETScVector const &x)
Definition LinAlg.cpp:27
auto meshLocations(Mesh const &mesh, MeshItemType const item_type)
Definition Mesh.h:238
static void executeSelectedMemberOnDereferenced(Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), ProcessLib::ProcessVariable::getName(), ProcessLib::ProcessVariable::getNumberOfGlobalComponents(), MeshLib::getOrCreateMeshProperty(), MeshLib::views::meshLocations(), MeshLib::Node, OGS_FATAL, ProcessLib::LocalAssemblerInterface::postTimestep(), and MathLib::LinAlg::setLocalAccessibleVector().

◆ preTimestepConcreteProcess()

template<int DisplacementDim>
void ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::preTimestepConcreteProcess ( std::vector< GlobalVector * > const & x,
double const t,
double const dt,
int const process_id )
overrideprivatevirtual

Reimplemented from ProcessLib::Process.

Definition at line 634 of file HydroMechanicsProcess.cpp.

637{
638 DBUG("PreTimestep HydroMechanicsProcess.");
639
642 getActiveElementIDs(), *_local_to_global_index_map, *x[process_id], t,
643 dt);
644}
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)

References DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), and ProcessLib::LocalAssemblerInterface::preTimestep().

◆ updateElementLevelSets()

template<int DisplacementDim>
void ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::updateElementLevelSets ( MeshLib::Element const & e,
MeshLib::Mesh & mesh )
private

Definition at line 314 of file HydroMechanicsProcess.cpp.

316{
317 Eigen::Vector3d const pt(getCenterOfGravity(e).asEigenVector3d());
318 std::vector<FractureProperty*> e_fracture_props;
319 std::unordered_map<int, int> e_fracID_to_local;
320 unsigned tmpi = 0;
321 for (auto fid : _process_data.vec_ele_connected_fractureIDs[e.getID()])
322 {
323 e_fracture_props.push_back(&_process_data.fracture_properties[fid]);
324 e_fracID_to_local.insert({fid, tmpi++});
325 }
326 std::vector<JunctionProperty*> e_junction_props;
327 std::unordered_map<int, int> e_juncID_to_local;
328 tmpi = 0;
329 for (auto fid : _process_data.vec_ele_connected_junctionIDs[e.getID()])
330 {
331 e_junction_props.push_back(&_process_data.junction_properties[fid]);
332 e_juncID_to_local.insert({fid, tmpi++});
333 }
334 std::vector<double> const levelsets(uGlobalEnrichments(
335 e_fracture_props, e_junction_props, e_fracID_to_local, pt));
336
337 auto update_levelset_property = [&](unsigned const i, int const id,
338 unsigned const levelset_idx_offset,
339 unsigned const name_offset)
340 {
341 auto levelset_property = MeshLib::getOrCreateMeshProperty<double>(
342 const_cast<MeshLib::Mesh&>(mesh),
343 "levelset" + std::to_string(id + 1 + name_offset),
345 levelset_property->resize(mesh.getNumberOfElements());
346 (*levelset_property)[e.getID()] = levelsets[i + levelset_idx_offset];
347 };
348
349 for (unsigned i = 0; i < e_fracture_props.size(); i++)
350 {
351 update_levelset_property(i, e_fracture_props[i]->fracture_id, 0, 0);
352 }
353 for (unsigned i = 0; i < e_junction_props.size(); i++)
354 {
355 update_levelset_property(i, e_junction_props[i]->junction_id,
356 e_fracture_props.size(),
357 _process_data.fracture_properties.size());
358 }
359}
MathLib::Point3d getCenterOfGravity(Element const &element)
Calculates the center of gravity for the mesh element.
Definition Element.cpp:142
std::vector< double > uGlobalEnrichments(std::vector< FractureProperty * > const &frac_props, std::vector< JunctionProperty * > const &junction_props, std::unordered_map< int, int > const &fracID_to_local, Eigen::Vector3d const &x)

References MeshLib::Cell, MeshLib::Element::getID(), MeshLib::Mesh::getNumberOfElements(), MeshLib::getOrCreateMeshProperty(), and ProcessLib::LIE::uGlobalEnrichments().

Member Data Documentation

◆ _local_assemblers

template<int DisplacementDim>
std::vector<std::unique_ptr<LocalAssemblerInterface> > ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_local_assemblers
private

Definition at line 85 of file HydroMechanicsProcess.h.

◆ _mesh_nodes_p

template<int DisplacementDim>
std::vector<MeshLib::Node*> ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_mesh_nodes_p
private

Definition at line 101 of file HydroMechanicsProcess.h.

◆ _mesh_subset_fracture_nodes

template<int DisplacementDim>
std::vector<std::unique_ptr<MeshLib::MeshSubset const> > ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_mesh_subset_fracture_nodes
private

Definition at line 97 of file HydroMechanicsProcess.h.

◆ _mesh_subset_junction_nodes

template<int DisplacementDim>
std::unique_ptr<MeshLib::MeshSubset const> ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_mesh_subset_junction_nodes
private

Definition at line 98 of file HydroMechanicsProcess.h.

◆ _mesh_subset_matrix_nodes

template<int DisplacementDim>
std::unique_ptr<MeshLib::MeshSubset const> ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_mesh_subset_matrix_nodes
private

Definition at line 99 of file HydroMechanicsProcess.h.

◆ _mesh_subset_nodes_p

template<int DisplacementDim>
std::unique_ptr<MeshLib::MeshSubset const> ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_mesh_subset_nodes_p
private

Definition at line 102 of file HydroMechanicsProcess.h.

◆ _process_data

template<int DisplacementDim>
HydroMechanicsProcessData<DisplacementDim> ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_process_data
private

◆ _vec_fracture_elements

template<int DisplacementDim>
std::vector<std::vector<MeshLib::Element*> > ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_fracture_elements
private

◆ _vec_fracture_mat_IDs

template<int DisplacementDim>
std::vector<int> ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_fracture_mat_IDs
private

◆ _vec_fracture_matrix_elements

template<int DisplacementDim>
std::vector<std::vector<MeshLib::Element*> > ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_fracture_matrix_elements
private

◆ _vec_fracture_nodes

template<int DisplacementDim>
std::vector<std::vector<MeshLib::Node*> > ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_fracture_nodes
private

◆ _vec_junction_fracture_matrix_elements

template<int DisplacementDim>
std::vector<std::vector<MeshLib::Element*> > ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_junction_fracture_matrix_elements
private

◆ _vec_junction_nodes

template<int DisplacementDim>
std::vector<MeshLib::Node*> ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_junction_nodes
private

◆ _vec_matrix_elements

template<int DisplacementDim>
std::vector<MeshLib::Element*> ProcessLib::LIE::HydroMechanics::HydroMechanicsProcess< DisplacementDim >::_vec_matrix_elements
private

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