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

Detailed Description

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

Definition at line 19 of file LIE/HydroMechanics/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
void setReleaseNodalForces (GlobalVector const *r_neq, int const process_id) 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 51 of file LIE/HydroMechanics/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 33 of file LIE/HydroMechanics/HydroMechanicsProcess.cpp.

48{
49 // For numerical Jacobian assembler
50 if (this->_jacobian_assembler->isPerturbationEnabled())
51 {
53 "The numericial Jacobian assembler is not supported for the "
54 "LIE HydroMechanics process.");
55 }
56
57 INFO("[LIE/HM] looking for fracture elements in the given mesh");
67
68 if (_vec_fracture_mat_IDs.size() !=
69 _process_data.fracture_properties.size())
70 {
72 "The number of the given fracture properties ({:d}) are not "
73 "consistent with the number of fracture groups in a mesh ({:d}).",
74 _process_data.fracture_properties.size(),
76 }
77
78 // create a map from a material ID to a fracture ID
81 _process_data.map_materialID_to_fractureID.resize(*max_frac_mat_id + 1);
82 for (unsigned i = 0; i < _vec_fracture_mat_IDs.size(); i++)
83 {
84 _process_data.map_materialID_to_fractureID[_vec_fracture_mat_IDs[i]] =
85 i;
86 }
87
88 // create a table of connected fracture IDs for each element
89 _process_data.vec_ele_connected_fractureIDs.resize(
90 mesh.getNumberOfElements());
91 for (unsigned i = 0; i < _vec_fracture_matrix_elements.size(); i++)
92 {
94 {
95 _process_data.vec_ele_connected_fractureIDs[e->getID()].push_back(
96 i);
97 }
98 }
99
100 // set fracture property
101 for (auto& fracture_prop : _process_data.fracture_properties)
102 {
103 // based on the 1st element assuming a fracture forms a straight line
106 *_vec_fracture_elements[fracture_prop.fracture_id][0],
108 }
109
110 // set branches
112 {
113 auto const master_matId = matID[0];
114 auto const slave_matId = matID[1];
115 auto& master_frac =
116 _process_data.fracture_properties
117 [_process_data.map_materialID_to_fractureID[master_matId]];
118 auto& slave_frac =
119 _process_data.fracture_properties
120 [_process_data.map_materialID_to_fractureID[slave_matId]];
121
122 master_frac.branches_master.push_back(createBranchProperty(
124
125 slave_frac.branches_slave.push_back(createBranchProperty(
127 }
128
129 // set junctions
134 {
135 return const_cast<MeshLib::Node*>(
136 _mesh.getNode(vec_junction_nodeID_matID.first));
137 });
138
139 for (std::size_t i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
140 {
141 auto const& material_ids = vec_junction_nodeID_matIDs[i].second;
142 assert(material_ids.size() == 2);
144 {_process_data.map_materialID_to_fractureID[material_ids[0]],
145 _process_data.map_materialID_to_fractureID[material_ids[1]]}};
146
147 _process_data.junction_properties.emplace_back(
148 i, *mesh.getNode(vec_junction_nodeID_matIDs[i].first),
150 }
151
152 // create a table of connected junction IDs for each element
153 _process_data.vec_ele_connected_junctionIDs.resize(
154 mesh.getNumberOfElements());
155 for (unsigned i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
156 {
157 auto node = mesh.getNode(vec_junction_nodeID_matIDs[i].first);
158 for (auto id :
159 mesh.getElementsConnectedToNode(*node) | MeshLib::views::ids)
160 {
161 _process_data.vec_ele_connected_junctionIDs[id].push_back(i);
162 }
163 }
164
165 // create a table of junction node and connected elements
168 for (unsigned i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
169 {
170 auto node = mesh.getNode(vec_junction_nodeID_matIDs[i].first);
171 for (auto e : mesh.getElementsConnectedToNode(*node))
172 {
174 const_cast<MeshLib::Element*>(e));
175 }
176 }
177
178 //
179 // If Neumann BCs for the displacement_jump variable are required they need
180 // special treatment because of the levelset function. The implementation
181 // exists in the version 6.1.0 (e54815cc07ee89c81f953a4955b1c788595dd725)
182 // and was removed due to lack of applications.
183 //
184
185 if (!_process_data.deactivate_matrix_in_flow)
186 {
187 _process_data.p_element_status =
189 }
190 else
191 {
192 auto const range =
194 if (!range)
195 {
196 OGS_FATAL(
197 "Could not get minimum/maximum ranges values for the "
198 "MaterialIDs property in the mesh '{:s}'.",
199 mesh.getName());
200 }
201
203 for (int matID = range->first; matID <= range->second; matID++)
204 {
208 {
209 vec_p_inactive_matIDs.push_back(matID);
210 }
211 }
212 _process_data.p_element_status =
215
216 const int monolithic_process_id = 0;
217 ProcessVariable const& pv_p =
219 _process_data.p0 = &pv_p.getInitialCondition();
220 }
222 mesh.getProperties().getPropertyVector<int>("MaterialIDs"));
223 _process_data.mesh_prop_materialIDs = material_ids;
224}
#define OGS_FATAL(...)
Definition Error.h:19
void INFO(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:28
static std::optional< std::pair< T, T > > const getValueBounds(MeshLib::PropertyVector< T > const &property)
std::vector< std::vector< MeshLib::Element * > > _vec_junction_fracture_matrix_elements
std::vector< std::vector< MeshLib::Element * > > _vec_fracture_elements
std::vector< std::vector< MeshLib::Element * > > _vec_fracture_matrix_elements
std::string const name
Definition Process.h:361
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:37
MeshLib::Mesh & _mesh
Definition Process.h:364
std::unique_ptr< ProcessLib::AbstractJacobianAssembler > _jacobian_assembler
Definition Process.h:375
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > const & getProcessVariables() const
Definition Process.h:149
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::Process(), ProcessLib::Process::_jacobian_assembler, ProcessLib::Process::_mesh, _process_data, _vec_fracture_elements, _vec_fracture_mat_IDs, _vec_fracture_matrix_elements, _vec_fracture_nodes, _vec_junction_fracture_matrix_elements, _vec_junction_nodes, _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(), ProcessLib::Process::name, 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 LIE/HydroMechanics/HydroMechanicsProcess.cpp.

594{
595 DBUG("Assemble HydroMechanicsProcess.");
596
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:22
std::vector< std::unique_ptr< LocalAssemblerInterface > > _local_assemblers
VectorMatrixAssembler _global_assembler
Definition Process.h:376
std::unique_ptr< NumLib::LocalToGlobalIndexMap > _local_to_global_index_map
Definition Process.h:367
static void executeMemberDereferenced(Object &object, Method method, Container const &container, Args &&... args)

References ProcessLib::Process::_global_assembler, _local_assemblers, ProcessLib::Process::_local_to_global_index_map, 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 LIE/HydroMechanics/HydroMechanicsProcess.cpp.

611{
612 DBUG("AssembleWithJacobian HydroMechanicsProcess.");
613
614 // Call global assembler for each local assembly item.
620 process_id, &b, &Jac);
621
622 auto copyRhs = [&](int const variable_id, auto& output_vector)
623 {
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:160
static void executeSelectedMemberDereferenced(Object &object, Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References ProcessLib::Process::_global_assembler, _local_assemblers, ProcessLib::Process::_local_to_global_index_map, _process_data, ProcessLib::VectorMatrixAssembler::assembleWithJacobian(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberDereferenced(), and ProcessLib::Process::getActiveElementIDs().

◆ 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 227 of file LIE/HydroMechanics/HydroMechanicsProcess.cpp.

228{
229 //------------------------------------------------------------
230 // prepare mesh subsets to define DoFs
231 //------------------------------------------------------------
232 // for extrapolation
235 // pressure
237 _process_data.p_element_status->getActiveElements());
240 // regular u
243 // u jump
244 for (unsigned i = 0; i < _vec_fracture_nodes.size(); i++)
245 {
249 }
250 // enrichment for junctions
253
254 // Collect the mesh subsets in a vector. (pressure, displacement,
255 // displacement_jump_fracture, and displacement_jump_junction)
259 [&]() { return *_mesh_subset_matrix_nodes; });
260 for (auto const& ms : _mesh_subset_fracture_nodes)
261 {
264 [&]() { return *ms; });
265 }
268 [&]() { return *_mesh_subset_junction_nodes; });
269
270 // The corresponding number of components for (pressure, displacement,
271 // displacement_jump_fracture, and displacement_jump_junction).
273 vec_n_components.push_back(1); // pressure
274 vec_n_components.insert(
275 vec_n_components.end(),
276 1 + _vec_fracture_mat_IDs.size() + _vec_junction_nodes.size(),
277 DisplacementDim); // all displacements
278
283 if (!_process_data.deactivate_matrix_in_flow)
284 {
285 vec_var_elements.push_back(&_mesh.getElements());
286 }
287 else
288 {
289 // TODO set elements including active nodes for pressure.
290 // cannot use ElementStatus
292 }
294 for (unsigned i = 0; i < _vec_fracture_matrix_elements.size(); i++)
295 {
297 }
298 for (unsigned i = 0; i < _vec_junction_fracture_matrix_elements.size(); i++)
299 {
301 }
302
303 INFO("[LIE/HM] creating a DoF table");
310
311 DBUG("[LIE/HM] created {:d} DoF", _local_to_global_index_map->size());
312}
std::vector< std::unique_ptr< MeshLib::MeshSubset const > > _mesh_subset_fracture_nodes
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_all_nodes
Definition Process.h:365
std::vector< Node * > getBaseNodes(std::vector< Element * > const &elements)

References ProcessLib::Process::_local_to_global_index_map, ProcessLib::Process::_mesh, _mesh_nodes_p, ProcessLib::Process::_mesh_subset_all_nodes, _mesh_subset_fracture_nodes, _mesh_subset_junction_nodes, _mesh_subset_matrix_nodes, _mesh_subset_nodes_p, _process_data, _vec_fracture_mat_IDs, _vec_fracture_matrix_elements, _vec_fracture_nodes, _vec_junction_fracture_matrix_elements, _vec_junction_nodes, _vec_matrix_elements, 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 363 of file LIE/HydroMechanics/HydroMechanicsProcess.cpp.

367{
368 assert(mesh.getDimension() == DisplacementDim);
369 INFO("[LIE/HM] creating local assemblers");
374 mesh.getElements(), dof_table, _local_assemblers,
375 NumLib::IntegrationOrder{integration_order}, mesh.isAxiallySymmetric(),
377
378 auto add_secondary_variable = [&](std::string const& name,
379 int const num_components,
381 {
382 _secondary_variables.addSecondaryVariable(
383 name,
387 };
388
393
394 add_secondary_variable("epsilon",
398
401
402 add_secondary_variable("fracture_velocity", DisplacementDim,
404
405 add_secondary_variable("fracture_stress", DisplacementDim,
407
408 add_secondary_variable("fracture_aperture", 1,
410
412 "fracture_permeability", 1,
414
416 const_cast<MeshLib::Mesh&>(mesh), "sigma_avg",
420
422 const_cast<MeshLib::Mesh&>(mesh), "velocity_avg",
424
425 for (MeshLib::Element const* e : _mesh.getElements())
426 {
427 if (e->getDimension() < DisplacementDim)
428 {
429 continue;
430 }
431
433 }
434
435 _process_data.element_local_jumps =
437 const_cast<MeshLib::Mesh&>(mesh), "local_jump_w_avg",
439
440 _process_data.element_fracture_stresses =
442 const_cast<MeshLib::Mesh&>(mesh), "fracture_stress_avg",
444
445 _process_data.element_fracture_velocities =
447 const_cast<MeshLib::Mesh&>(mesh), "fracture_velocity_avg",
449
451 const_cast<MeshLib::Mesh&>(mesh), "fracture_aperture_avg",
453
454 mesh_prop_b->resize(mesh.getNumberOfElements());
455 auto const& mesh_prop_matid = *_process_data.mesh_prop_materialIDs;
456 for (auto const& fracture_prop : _process_data.fracture_properties)
457 {
458 for (MeshLib::Element const* e : _mesh.getElements())
459 {
460 if (e->getDimension() == DisplacementDim)
461 {
462 continue;
463 }
464 if (mesh_prop_matid[e->getID()] != fracture_prop.mat_id)
465 {
466 continue;
467 }
468 // Mean value for the element. This allows usage of node based
469 // properties for aperture.
470 (*mesh_prop_b)[e->getID()] =
471 fracture_prop.aperture0
472 .getNodalValuesOnElement(*e, /*time independent*/ 0)
473 .mean();
474 }
475 }
476
478 const_cast<MeshLib::Mesh&>(mesh), "fracture_permeability_avg",
480 mesh_prop_k_f->resize(mesh.getNumberOfElements());
481 _process_data.mesh_prop_k_f = mesh_prop_k_f;
482
485 const_cast<MeshLib::Mesh&>(mesh), "f_shear_failure",
487 mesh_prop_fracture_shear_failure->resize(mesh.getNumberOfElements());
488 _process_data.mesh_prop_fracture_shear_failure =
490
492 const_cast<MeshLib::Mesh&>(mesh), "pressure_interpolated",
494 mesh_prop_nodal_p->resize(mesh.getNumberOfNodes());
495 _process_data.mesh_prop_nodal_p = mesh_prop_nodal_p;
496
497 _process_data.mesh_prop_nodal_forces =
499 const_cast<MeshLib::Mesh&>(mesh), "NodalForces",
501 assert(_process_data.mesh_prop_nodal_forces->size() ==
502 DisplacementDim * mesh.getNumberOfNodes());
503
504 _process_data.mesh_prop_nodal_forces_jump =
506 const_cast<MeshLib::Mesh&>(mesh), "NodalForcesJump",
508 assert(_process_data.mesh_prop_nodal_forces_jump->size() ==
509 DisplacementDim * mesh.getNumberOfNodes());
510
511 _process_data.mesh_prop_hydraulic_flow =
513 const_cast<MeshLib::Mesh&>(mesh), "VolumetricFlowRate",
515 assert(_process_data.mesh_prop_hydraulic_flow->size() ==
516 mesh.getNumberOfNodes());
517 _process_data.mesh_prop_b = mesh_prop_b;
518}
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:369
NumLib::Extrapolator & getExtrapolator() const
Definition Process.h:201
PropertyVector< T > * getOrCreateMeshProperty(Mesh &mesh, std::string const &property_name, MeshItemType const item_type, int const number_of_components)
SecondaryVariableFunctions makeExtrapolator(const unsigned num_components, NumLib::Extrapolator &extrapolator, LocalAssemblerCollection const &local_assemblers, typename NumLib::ExtrapolatableLocalAssemblerCollection< LocalAssemblerCollection >::IntegrationPointValuesMethod integration_point_values_method)

References _local_assemblers, ProcessLib::Process::_mesh, _process_data, ProcessLib::Process::_secondary_variables, MeshLib::Cell, ProcessLib::LIE::HydroMechanics::createLocalAssemblers(), MeshLib::Mesh::getDimension(), MeshLib::Mesh::getElements(), ProcessLib::Process::getExtrapolator(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerInterface::getIntPtDarcyVelocity(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerInterface::getIntPtEpsilon(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerInterface::getIntPtFractureAperture(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerInterface::getIntPtFracturePermeability(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerInterface::getIntPtFractureStress(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerInterface::getIntPtFractureVelocity(), ProcessLib::LIE::HydroMechanics::HydroMechanicsLocalAssemblerInterface::getIntPtSigma(), MeshLib::Mesh::getNumberOfElements(), MeshLib::Mesh::getNumberOfNodes(), MeshLib::getOrCreateMeshProperty(), INFO(), MeshLib::Mesh::isAxiallySymmetric(), ProcessLib::makeExtrapolator(), ProcessLib::Process::name, MeshLib::Node, and updateElementLevelSets().

◆ isLinear()

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

Definition at line 584 of file LIE/HydroMechanics/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 521 of file LIE/HydroMechanics/HydroMechanicsProcess.cpp.

525{
526 if (process_id == 0)
527 {
528 DBUG("PostTimestep HydroMechanicsProcess.");
529
533 x_prev, t, dt, process_id);
534 }
535
536 DBUG("Compute the secondary variables for HydroMechanicsProcess.");
537
538 const auto& dof_table = getDOFTable(process_id);
539
540 // Copy displacement jumps in a solution vector to mesh property
541 // Remark: the copy is required because mesh properties for primary
542 // variables are set during output and are not ready yet when this function
543 // is called.
544 int g_variable_id = 0;
545 {
546 const int monolithic_process_id = 0;
548 auto const it =
549 std::find_if(pvs.begin(), pvs.end(), [](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;
564 auto const num_comp = pv_g.getNumberOfGlobalComponents();
568 {
569 auto const& mesh_subset =
570 dof_table.getMeshSubset(g_variable_id, component_id);
571 for (auto const& l : MeshLib::views::meshLocations(
573 {
574 auto const global_index =
575 dof_table.getGlobalIndex(l, g_variable_id, component_id);
576 auto const node_id = l.item_id;
579 }
580 }
581}
std::vector< NumLib::LocalToGlobalIndexMap const * > getDOFTables(int const number_of_processes) const
Definition Process.cpp:376
virtual NumLib::LocalToGlobalIndexMap const & getDOFTable(const int) const
Definition Process.h:140
void setLocalAccessibleVector(PETScVector const &x)
Definition LinAlg.cpp:20
static void executeSelectedMemberOnDereferenced(Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References _local_assemblers, ProcessLib::Process::_mesh, DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), ProcessLib::Process::getActiveElementIDs(), ProcessLib::Process::getDOFTable(), ProcessLib::Process::getDOFTables(), ProcessLib::ProcessVariable::getName(), ProcessLib::ProcessVariable::getNumberOfGlobalComponents(), MeshLib::getOrCreateMeshProperty(), ProcessLib::Process::getProcessVariables(), 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

◆ updateElementLevelSets()

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

Definition at line 315 of file LIE/HydroMechanics/HydroMechanicsProcess.cpp.

317{
321 unsigned tmpi = 0;
322 for (auto fid : _process_data.vec_ele_connected_fractureIDs[e.getID()])
323 {
324 e_fracture_props.push_back(&_process_data.fracture_properties[fid]);
325 e_fracID_to_local.insert({fid, tmpi++});
326 }
329 tmpi = 0;
330 for (auto fid : _process_data.vec_ele_connected_junctionIDs[e.getID()])
331 {
332 e_junction_props.push_back(&_process_data.junction_properties[fid]);
333 e_juncID_to_local.insert({fid, tmpi++});
334 }
337
338 auto update_levelset_property = [&](unsigned const i, int const id,
339 unsigned const levelset_idx_offset,
340 unsigned const name_offset)
341 {
343 const_cast<MeshLib::Mesh&>(mesh),
344 "levelset" + std::to_string(id + 1 + name_offset),
346 levelset_property->resize(mesh.getNumberOfElements());
347 (*levelset_property)[e.getID()] = levelsets[i + levelset_idx_offset];
348 };
349
350 for (unsigned i = 0; i < e_fracture_props.size(); i++)
351 {
353 }
354 for (unsigned i = 0; i < e_junction_props.size(); i++)
355 {
357 e_fracture_props.size(),
358 _process_data.fracture_properties.size());
359 }
360}
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 _process_data, MeshLib::Cell, MeshLib::Element::getID(), MeshLib::Mesh::getNumberOfElements(), MeshLib::getOrCreateMeshProperty(), and ProcessLib::LIE::uGlobalEnrichments().

Referenced by initializeConcreteProcess().

Member Data Documentation

◆ _local_assemblers

◆ _mesh_nodes_p

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

Definition at line 94 of file LIE/HydroMechanics/HydroMechanicsProcess.h.

Referenced by constructDofTable().

◆ _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 90 of file LIE/HydroMechanics/HydroMechanicsProcess.h.

Referenced by constructDofTable().

◆ _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 91 of file LIE/HydroMechanics/HydroMechanicsProcess.h.

Referenced by constructDofTable().

◆ _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 92 of file LIE/HydroMechanics/HydroMechanicsProcess.h.

Referenced by constructDofTable().

◆ _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 95 of file LIE/HydroMechanics/HydroMechanicsProcess.h.

Referenced by constructDofTable().

◆ _process_data

◆ _vec_fracture_elements

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

Definition at line 82 of file LIE/HydroMechanics/HydroMechanicsProcess.h.

Referenced by HydroMechanicsProcess().

◆ _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: