OGS
ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim > Class Template Referencefinal

Detailed Description

template<int DisplacementDim>
class ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >

Definition at line 24 of file SmallDeformationProcess.h.

#include <SmallDeformationProcess.h>

Inheritance diagram for ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >:
[legend]
Collaboration diagram for ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >:
[legend]

Public Member Functions

 SmallDeformationProcess (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, SmallDeformationProcessData< DisplacementDim > &&process_data, SecondaryVariableCollection &&secondary_variables)
 
void computeSecondaryVariableConcrete (double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_prev, 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, GlobalMatrix &M, GlobalMatrix &K, 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::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)
 
- Public Member Functions inherited from ProcessLib::SubmeshAssemblySupport
virtual std::vector< std::string > initializeAssemblyOnSubmeshes (std::vector< std::reference_wrapper< MeshLib::Mesh > > const &meshes)
 
virtual ~SubmeshAssemblySupport ()=default
 

Private Types

using LocalAssemblerInterface = SmallDeformationLocalAssemblerInterface
 

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, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b, GlobalMatrix &Jac) override
 
void preTimestepConcreteProcess (std::vector< GlobalVector * > const &x, double const t, double const dt, const int process_id) override
 

Private Attributes

SmallDeformationProcessData< DisplacementDim > _process_data
 
std::vector< std::unique_ptr< LocalAssemblerInterface > > _local_assemblers
 
std::unique_ptr< NumLib::LocalToGlobalIndexMap_local_to_global_index_map_single_component
 
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
 

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
 
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::SmallDeformation::SmallDeformationProcess< DisplacementDim >::LocalAssemblerInterface = SmallDeformationLocalAssemblerInterface
private

Definition at line 55 of file SmallDeformationProcess.h.

Constructor & Destructor Documentation

◆ SmallDeformationProcess()

template<int DisplacementDim>
ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::SmallDeformationProcess ( 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,
SmallDeformationProcessData< DisplacementDim > && process_data,
SecondaryVariableCollection && secondary_variables )

Definition at line 32 of file SmallDeformationProcess.cpp.

42 : Process(std::move(name), mesh, std::move(jacobian_assembler), parameters,
43 integration_order, std::move(process_variables),
44 std::move(secondary_variables)),
45 _process_data(std::move(process_data))
46{
47 std::vector<std::pair<std::size_t, std::vector<int>>>
48 vec_branch_nodeID_matIDs;
49 std::vector<std::pair<std::size_t, std::vector<int>>>
50 vec_junction_nodeID_matIDs;
54 _vec_fracture_nodes, vec_branch_nodeID_matIDs,
55 vec_junction_nodeID_matIDs);
56
57 if (_vec_fracture_mat_IDs.size() !=
58 _process_data.fracture_properties.size())
59 {
61 "The number of the given fracture properties ({:d}) are not "
62 "consistent with the number of fracture groups in a mesh ({:d}).",
63 _process_data.fracture_properties.size(),
65 }
66
67 // create a map from a material ID to a fracture ID
68 auto max_frac_mat_id = std::max_element(_vec_fracture_mat_IDs.begin(),
70 _process_data._map_materialID_to_fractureID.resize(*max_frac_mat_id + 1);
71 for (unsigned i = 0; i < _vec_fracture_mat_IDs.size(); i++)
72 {
73 _process_data._map_materialID_to_fractureID[_vec_fracture_mat_IDs[i]] =
74 i;
75 }
76
77 // create a table of connected fracture IDs for each element
78 _process_data._vec_ele_connected_fractureIDs.resize(
79 mesh.getNumberOfElements());
80 for (unsigned i = 0; i < _vec_fracture_matrix_elements.size(); i++)
81 {
82 for (auto e : _vec_fracture_matrix_elements[i])
83 {
84 _process_data._vec_ele_connected_fractureIDs[e->getID()].push_back(
85 i);
86 }
87 }
88
89 // set fracture property
90 for (auto& fracture_prop : _process_data.fracture_properties)
91 {
92 // based on the 1st element assuming a fracture forms a straight line
94 DisplacementDim,
95 *_vec_fracture_elements[fracture_prop.fracture_id][0],
96 fracture_prop);
97 }
98
99 // set branches
100 for (auto const& [vec_branch_nodeID, matID] : vec_branch_nodeID_matIDs)
101 {
102 auto master_matId = matID[0];
103 auto slave_matId = matID[1];
104 auto& master_frac =
105 _process_data.fracture_properties
106 [_process_data._map_materialID_to_fractureID[master_matId]];
107 auto& slave_frac =
108 _process_data.fracture_properties
109 [_process_data._map_materialID_to_fractureID[slave_matId]];
110
111 master_frac.branches_master.push_back(createBranchProperty(
112 *mesh.getNode(vec_branch_nodeID), master_frac, slave_frac));
113
114 slave_frac.branches_slave.push_back(createBranchProperty(
115 *mesh.getNode(vec_branch_nodeID), master_frac, slave_frac));
116 }
117
118 // set junctions
119 transform(cbegin(vec_junction_nodeID_matIDs),
120 cend(vec_junction_nodeID_matIDs),
121 back_inserter(_vec_junction_nodes),
122 [&](auto& vec_junction_nodeID_matID)
123 {
124 return const_cast<MeshLib::Node*>(
125 _mesh.getNode(vec_junction_nodeID_matID.first));
126 });
127
128 for (std::size_t i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
129 {
130 auto const& material_ids = vec_junction_nodeID_matIDs[i].second;
131 assert(material_ids.size() == 2);
132 std::array<int, 2> fracture_ids{
133 {_process_data._map_materialID_to_fractureID[material_ids[0]],
134 _process_data._map_materialID_to_fractureID[material_ids[1]]}};
135
136 _process_data.junction_properties.emplace_back(
137 i, *mesh.getNode(vec_junction_nodeID_matIDs[i].first),
138 fracture_ids);
139 }
140
141 // create a table of connected junction IDs for each element
142 _process_data._vec_ele_connected_junctionIDs.resize(
143 mesh.getNumberOfElements());
144 for (unsigned i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
145 {
146 auto node = mesh.getNode(vec_junction_nodeID_matIDs[i].first);
147 for (auto id :
148 mesh.getElementsConnectedToNode(*node) | MeshLib::views::ids)
149 {
150 _process_data._vec_ele_connected_junctionIDs[id].push_back(i);
151 }
152 }
153
154 // create a table of junction node and connected elements
156 vec_junction_nodeID_matIDs.size());
157 for (unsigned i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
158 {
159 auto node = mesh.getNode(vec_junction_nodeID_matIDs[i].first);
160 for (auto e : mesh.getElementsConnectedToNode(*node))
161 {
163 const_cast<MeshLib::Element*>(e));
164 }
165 }
166
167 //
168 // If Neumann BCs for the displacement_jump variable are required they need
169 // special treatment because of the levelset function. The implementation
170 // exists in the version 6.1.0 (e54815cc07ee89c81f953a4955b1c788595dd725)
171 // and was removed due to lack of applications.
172 //
173
174 MeshLib::PropertyVector<int> const* material_ids(
175 mesh.getProperties().getPropertyVector<int>("MaterialIDs"));
176 _process_data._mesh_prop_materialIDs = material_ids;
177}
#define OGS_FATAL(...)
Definition Error.h:26
const Node * getNode(std::size_t idx) const
Get the node with the given index.
Definition Mesh.h:91
Properties & getProperties()
Definition Mesh.h:134
std::size_t getNumberOfElements() const
Get the number of elements.
Definition Mesh.h:97
PropertyVector< T > const * getPropertyVector(std::string_view name) const
std::vector< std::vector< MeshLib::Element * > > _vec_junction_fracture_matrix_elements
std::vector< std::vector< MeshLib::Node * > > _vec_fracture_nodes
std::vector< std::vector< MeshLib::Element * > > _vec_fracture_elements
std::vector< std::vector< MeshLib::Element * > > _vec_fracture_matrix_elements
SmallDeformationProcessData< DisplacementDim > _process_data
std::string const name
Definition Process.h:354
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:357
constexpr ranges::views::view_closure ids
For an element of a range view return its id.
Definition Mesh.h:225
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::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_process_data, ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_fracture_elements, ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_fracture_mat_IDs, ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_fracture_matrix_elements, ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_fracture_nodes, ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_junction_fracture_matrix_elements, ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_junction_nodes, ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_matrix_elements, ProcessLib::LIE::createBranchProperty(), MeshLib::Mesh::getElementsConnectedToNode(), ProcessLib::LIE::getFractureMatrixDataInMesh(), MeshLib::Mesh::getNode(), MeshLib::Mesh::getNumberOfElements(), MeshLib::Mesh::getProperties(), MeshLib::Properties::getPropertyVector(), MeshLib::views::ids, OGS_FATAL, and ProcessLib::LIE::setFractureProperty().

Member Function Documentation

◆ assembleConcreteProcess()

template<int DisplacementDim>
void ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< 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 413 of file SmallDeformationProcess.cpp.

417{
418 DBUG("Assemble SmallDeformationProcess.");
419
420 ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
421
422 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_table = {
424 // Call global assembler for each local assembly item.
427 pv.getActiveElementIDs(), dof_table, t, dt, x, x_prev, process_id, M, K,
428 b);
429}
void DBUG(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:30
std::vector< std::unique_ptr< LocalAssemblerInterface > > _local_assemblers
std::vector< std::size_t > const & getActiveElementIDs() const
std::vector< std::reference_wrapper< ProcessVariable > > const & getProcessVariables(const int process_id) const
Definition Process.h:155
VectorMatrixAssembler _global_assembler
Definition Process.h:367
std::unique_ptr< NumLib::LocalToGlobalIndexMap > _local_to_global_index_map
Definition Process.h:360
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 executeSelectedMemberDereferenced(Object &object, Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References ProcessLib::VectorMatrixAssembler::assemble(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberDereferenced(), and ProcessLib::ProcessVariable::getActiveElementIDs().

◆ assembleWithJacobianConcreteProcess()

template<int DisplacementDim>
void ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::assembleWithJacobianConcreteProcess ( 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,
GlobalMatrix & Jac )
overrideprivatevirtual

Implements ProcessLib::Process.

Definition at line 431 of file SmallDeformationProcess.cpp.

436{
437 DBUG("AssembleWithJacobian SmallDeformationProcess.");
438
439 // Call global assembler for each local assembly item.
440 ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
441
442 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_table = {
446 _local_assemblers, pv.getActiveElementIDs(), dof_table, t, dt, x,
447 x_prev, process_id, M, K, b, Jac);
448}
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, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b, GlobalMatrix &Jac)

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

◆ computeSecondaryVariableConcrete()

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

Reimplemented from ProcessLib::Process.

Definition at line 389 of file SmallDeformationProcess.cpp.

392{
393 DBUG("Compute the secondary variables for SmallDeformationProcess.");
394 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_tables;
395 dof_tables.reserve(x.size());
396 std::generate_n(std::back_inserter(dof_tables), x.size(),
397 [&]() { return _local_to_global_index_map.get(); });
398
399 ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
402 _local_assemblers, pv.getActiveElementIDs(), dof_tables, t, dt, x,
403 x_prev, process_id);
404}
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)
static void executeSelectedMemberOnDereferenced(Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References ProcessLib::LocalAssemblerInterface::computeSecondaryVariable(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), and ProcessLib::ProcessVariable::getActiveElementIDs().

◆ constructDofTable()

template<int DisplacementDim>
void ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< 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 180 of file SmallDeformationProcess.cpp.

181{
182 //------------------------------------------------------------
183 // prepare mesh subsets to define DoFs
184 //------------------------------------------------------------
185 // for extrapolation
187 std::make_unique<MeshLib::MeshSubset>(_mesh, _mesh.getNodes());
188 // regular u
190 std::make_unique<MeshLib::MeshSubset>(_mesh, _mesh.getNodes());
191 // u jump
192 for (unsigned i = 0; i < _vec_fracture_nodes.size(); i++)
193 {
195 std::make_unique<MeshLib::MeshSubset const>(
197 }
198 // enrichment for junctions
200 std::make_unique<MeshLib::MeshSubset>(_mesh, _vec_junction_nodes);
201
202 // Collect the mesh subsets in a vector.
203 std::vector<MeshLib::MeshSubset> all_mesh_subsets;
204 std::generate_n(std::back_inserter(all_mesh_subsets), DisplacementDim,
205 [&]() { return *_mesh_subset_matrix_nodes; });
206 for (auto const& ms : _mesh_subset_fracture_nodes)
207 {
208 std::generate_n(std::back_inserter(all_mesh_subsets),
209 DisplacementDim,
210 [&]() { return *ms; });
211 }
212 std::generate_n(std::back_inserter(all_mesh_subsets),
213 DisplacementDim,
214 [&]() { return *_mesh_subset_junction_nodes; });
215
216 std::vector<int> const vec_n_components(
217 1 + _vec_fracture_mat_IDs.size() + _vec_junction_nodes.size(),
218 DisplacementDim);
219
220 std::vector<std::vector<MeshLib::Element*> const*> vec_var_elements;
221 vec_var_elements.push_back(&_vec_matrix_elements);
222 for (unsigned i = 0; i < _vec_fracture_matrix_elements.size(); i++)
223 {
224 vec_var_elements.push_back(&_vec_fracture_matrix_elements[i]);
225 }
226 for (unsigned i = 0; i < _vec_junction_fracture_matrix_elements.size(); i++)
227 {
228 vec_var_elements.push_back(&_vec_junction_fracture_matrix_elements[i]);
229 }
230
232 std::make_unique<NumLib::LocalToGlobalIndexMap>(
233 std::move(all_mesh_subsets),
234 vec_n_components,
235 vec_var_elements,
237}
std::vector< Node * > const & getNodes() const
Get the nodes-vector for the mesh.
Definition Mesh.h:106
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::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_all_nodes
Definition Process.h:358
@ BY_COMPONENT
Ordering data by component type.

References NumLib::BY_COMPONENT.

◆ initializeConcreteProcess()

template<int DisplacementDim>
void ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< 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 240 of file SmallDeformationProcess.cpp.

244{
246 DisplacementDim, SmallDeformationLocalAssemblerMatrix,
247 SmallDeformationLocalAssemblerMatrixNearFracture,
248 SmallDeformationLocalAssemblerFracture>(
249 mesh.getElements(), dof_table, _local_assemblers,
250 NumLib::IntegrationOrder{integration_order}, mesh.isAxiallySymmetric(),
252
253 // TODO move the two data members somewhere else.
254 // for extrapolation of secondary variables
255 std::vector<MeshLib::MeshSubset> all_mesh_subsets_single_component{
258 std::make_unique<NumLib::LocalToGlobalIndexMap>(
259 std::move(all_mesh_subsets_single_component),
260 // by location order is needed for output
262
263 auto add_secondary_variable = [&](std::string const& name,
264 int const num_components,
265 auto get_ip_values_function)
266 {
268 name,
269 makeExtrapolator(num_components, getExtrapolator(),
271 std::move(get_ip_values_function)));
272 };
273
274 add_secondary_variable("sigma",
276 DisplacementDim>::RowsAtCompileTime,
278
279 add_secondary_variable("epsilon",
281 DisplacementDim>::RowsAtCompileTime,
283
284 add_secondary_variable("fracture_stress", DisplacementDim,
286
287 add_secondary_variable("fracture_aperture", 1,
289
290 _process_data.element_stresses = MeshLib::getOrCreateMeshProperty<double>(
291 const_cast<MeshLib::Mesh&>(mesh), "sigma_avg",
294 DisplacementDim>::RowsAtCompileTime);
295
296 for (MeshLib::Element const* e : _mesh.getElements())
297 {
298 if (e->getDimension() < DisplacementDim)
299 {
300 continue;
301 }
302
303 Eigen::Vector3d const pt(getCenterOfGravity(*e).asEigenVector3d());
304 std::vector<FractureProperty*> e_fracture_props;
305 std::unordered_map<int, int> e_fracID_to_local;
306 unsigned tmpi = 0;
307 for (auto fid :
308 _process_data._vec_ele_connected_fractureIDs[e->getID()])
309 {
310 e_fracture_props.push_back(&_process_data.fracture_properties[fid]);
311 e_fracID_to_local.insert({fid, tmpi++});
312 }
313 std::vector<JunctionProperty*> e_junction_props;
314 std::unordered_map<int, int> e_juncID_to_local;
315 tmpi = 0;
316 for (auto fid :
317 _process_data._vec_ele_connected_junctionIDs[e->getID()])
318 {
319 e_junction_props.push_back(&_process_data.junction_properties[fid]);
320 e_juncID_to_local.insert({fid, tmpi++});
321 }
322 std::vector<double> const levelsets(uGlobalEnrichments(
323 e_fracture_props, e_junction_props, e_fracID_to_local, pt));
324
325 for (unsigned i = 0; i < e_fracture_props.size(); i++)
326 {
327 auto mesh_prop_levelset = MeshLib::getOrCreateMeshProperty<double>(
328 const_cast<MeshLib::Mesh&>(mesh),
329 "levelset" +
330 std::to_string(e_fracture_props[i]->fracture_id + 1),
332 mesh_prop_levelset->resize(mesh.getNumberOfElements());
333 (*mesh_prop_levelset)[e->getID()] = levelsets[i];
334 }
335 for (unsigned i = 0; i < e_junction_props.size(); i++)
336 {
337 auto mesh_prop_levelset = MeshLib::getOrCreateMeshProperty<double>(
338 const_cast<MeshLib::Mesh&>(mesh),
339 "levelset" +
340 std::to_string(e_junction_props[i]->junction_id + 1 +
341 _process_data.fracture_properties.size()),
343 mesh_prop_levelset->resize(mesh.getNumberOfElements());
344 (*mesh_prop_levelset)[e->getID()] =
345 levelsets[i + e_fracture_props.size()];
346 }
347 }
348
349 _process_data.element_local_jumps =
350 MeshLib::getOrCreateMeshProperty<double>(
351 const_cast<MeshLib::Mesh&>(mesh), "local_jump_w_avg",
352 MeshLib::MeshItemType::Cell, DisplacementDim);
353
354 _process_data.element_fracture_stresses =
355 MeshLib::getOrCreateMeshProperty<double>(
356 const_cast<MeshLib::Mesh&>(mesh), "fracture_stress_avg",
357 MeshLib::MeshItemType::Cell, DisplacementDim);
358
359 auto mesh_prop_b = MeshLib::getOrCreateMeshProperty<double>(
360 const_cast<MeshLib::Mesh&>(mesh), "fracture_aperture_avg",
362
363 mesh_prop_b->resize(mesh.getNumberOfElements());
364 auto const& mesh_prop_matid = *_process_data._mesh_prop_materialIDs;
365 for (auto const& fracture_prop : _process_data.fracture_properties)
366 {
367 for (MeshLib::Element const* e : _mesh.getElements())
368 {
369 if (e->getDimension() == DisplacementDim)
370 {
371 continue;
372 }
373 if (mesh_prop_matid[e->getID()] != fracture_prop.mat_id)
374 {
375 continue;
376 }
377 // Mean value for the element. This allows usage of node based
378 // properties for aperture.
379 (*mesh_prop_b)[e->getID()] =
380 fracture_prop.aperture0
381 .getNodalValuesOnElement(*e, /*time independent*/ 0)
382 .mean();
383 }
384 }
385 _process_data._mesh_prop_b = mesh_prop_b;
386}
Eigen::Vector3d const & asEigenVector3d() const
Definition Point3d.h:63
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 & 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 & getIntPtSigma(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
std::unique_ptr< NumLib::LocalToGlobalIndexMap > _local_to_global_index_map_single_component
SecondaryVariableCollection _secondary_variables
Definition Process.h:362
NumLib::Extrapolator & getExtrapolator() const
Definition Process.h:199
void addSecondaryVariable(std::string const &internal_name, SecondaryVariableFunctions &&fcts)
Eigen::Matrix< double, kelvin_vector_dimensions(DisplacementDim), 1, Eigen::ColMajor > KelvinVectorType
MathLib::Point3d getCenterOfGravity(Element const &element)
Calculates the center of gravity for the mesh element.
Definition Element.cpp:124
@ BY_LOCATION
Ordering data by spatial location.
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)
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)
SecondaryVariableFunctions makeExtrapolator(const unsigned num_components, NumLib::Extrapolator &extrapolator, LocalAssemblerCollection const &local_assemblers, typename NumLib::ExtrapolatableLocalAssemblerCollection< LocalAssemblerCollection >::IntegrationPointValuesMethod integration_point_values_method)

References MathLib::Point3d::asEigenVector3d(), NumLib::BY_LOCATION, MeshLib::Cell, ProcessLib::LIE::SmallDeformation::createLocalAssemblers(), MeshLib::Mesh::getElements(), MeshLib::Mesh::getNumberOfElements(), MeshLib::Mesh::isAxiallySymmetric(), ProcessLib::makeExtrapolator(), and ProcessLib::LIE::uGlobalEnrichments().

◆ isLinear()

template<int DisplacementDim>
bool ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::isLinear ( ) const
override

Definition at line 407 of file SmallDeformationProcess.cpp.

408{
409 return false;
410}

◆ preTimestepConcreteProcess()

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

Reimplemented from ProcessLib::Process.

Definition at line 450 of file SmallDeformationProcess.cpp.

453{
454 DBUG("PreTimestep SmallDeformationProcess.");
455
456 ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
460 *_local_to_global_index_map, *x[process_id], t, dt);
461}
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(), ProcessLib::ProcessVariable::getActiveElementIDs(), and ProcessLib::LocalAssemblerInterface::preTimestep().

Member Data Documentation

◆ _local_assemblers

template<int DisplacementDim>
std::vector<std::unique_ptr<LocalAssemblerInterface> > ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_local_assemblers
private

Definition at line 83 of file SmallDeformationProcess.h.

◆ _local_to_global_index_map_single_component

template<int DisplacementDim>
std::unique_ptr<NumLib::LocalToGlobalIndexMap> ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_local_to_global_index_map_single_component
private

Definition at line 86 of file SmallDeformationProcess.h.

◆ _mesh_subset_fracture_nodes

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

Definition at line 98 of file SmallDeformationProcess.h.

◆ _mesh_subset_junction_nodes

template<int DisplacementDim>
std::unique_ptr<MeshLib::MeshSubset const> ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_mesh_subset_junction_nodes
private

Definition at line 99 of file SmallDeformationProcess.h.

◆ _mesh_subset_matrix_nodes

template<int DisplacementDim>
std::unique_ptr<MeshLib::MeshSubset const> ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_mesh_subset_matrix_nodes
private

Definition at line 100 of file SmallDeformationProcess.h.

◆ _process_data

◆ _vec_fracture_elements

template<int DisplacementDim>
std::vector<std::vector<MeshLib::Element*> > ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_fracture_elements
private

◆ _vec_fracture_mat_IDs

template<int DisplacementDim>
std::vector<int> ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_fracture_mat_IDs
private

◆ _vec_fracture_matrix_elements

template<int DisplacementDim>
std::vector<std::vector<MeshLib::Element*> > ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_fracture_matrix_elements
private

◆ _vec_fracture_nodes

template<int DisplacementDim>
std::vector<std::vector<MeshLib::Node*> > ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_fracture_nodes
private

◆ _vec_junction_fracture_matrix_elements

template<int DisplacementDim>
std::vector<std::vector<MeshLib::Element*> > ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_junction_fracture_matrix_elements
private

◆ _vec_junction_nodes

template<int DisplacementDim>
std::vector<MeshLib::Node*> ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_junction_nodes
private

◆ _vec_matrix_elements

template<int DisplacementDim>
std::vector<MeshLib::Element*> ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_vec_matrix_elements
private

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