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

Detailed Description

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

Definition at line 17 of file LIE/SmallDeformation/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, 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 = 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, GlobalVector &b, GlobalMatrix &Jac) override
void preTimestepConcreteProcess (std::vector< GlobalVector * > const &x, double const t, double const dt, const int process_id) override
void updateElementLevelSets (MeshLib::Element const &e, MeshLib::Mesh &mesh)

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

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 25 of file LIE/SmallDeformation/SmallDeformationProcess.cpp.

39{
40 // For numerical Jacobian assembler
41 if (this->_jacobian_assembler->isPerturbationEnabled())
42 {
44 "The numericial Jacobian assembler is not supported for the "
45 "LIE SmallDeformationProcess.");
46 }
47
48 INFO("[LIE/M] looking for fracture elements in the given mesh");
58
59 if (_vec_fracture_mat_IDs.size() !=
60 _process_data.fracture_properties.size())
61 {
63 "The number of the given fracture properties ({:d}) are not "
64 "consistent with the number of fracture groups in a mesh "
65 "({:d}).",
66 _process_data.fracture_properties.size(),
68 }
69
70 // create a map from a material ID to a fracture ID
73 _process_data.map_materialID_to_fractureID.resize(*max_frac_mat_id + 1);
74 for (unsigned i = 0; i < _vec_fracture_mat_IDs.size(); i++)
75 {
76 _process_data.map_materialID_to_fractureID[_vec_fracture_mat_IDs[i]] =
77 i;
78 }
79
80 // create a table of connected fracture IDs for each element
81 _process_data.vec_ele_connected_fractureIDs.resize(
82 mesh.getNumberOfElements());
83 for (unsigned i = 0; i < _vec_fracture_matrix_elements.size(); i++)
84 {
86 {
87 _process_data.vec_ele_connected_fractureIDs[e->getID()].push_back(
88 i);
89 }
90 }
91
92 // set fracture property
93 for (auto& fracture_prop : _process_data.fracture_properties)
94 {
95 // based on the 1st element assuming a fracture forms a straight
96 // line
101 }
102
103 // set branches
105 {
106 auto const master_matId = matID[0];
107 auto const slave_matId = matID[1];
108 auto& master_frac =
109 _process_data.fracture_properties
110 [_process_data.map_materialID_to_fractureID[master_matId]];
111 auto& slave_frac =
112 _process_data.fracture_properties
113 [_process_data.map_materialID_to_fractureID[slave_matId]];
114
115 master_frac.branches_master.push_back(createBranchProperty(
117
118 slave_frac.branches_slave.push_back(createBranchProperty(
120 }
121
122 // set junctions
127 {
128 return const_cast<MeshLib::Node*>(
129 _mesh.getNode(vec_junction_nodeID_matID.first));
130 });
131
132 for (std::size_t i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
133 {
134 auto const& material_ids = vec_junction_nodeID_matIDs[i].second;
135 assert(material_ids.size() == 2);
137 {_process_data.map_materialID_to_fractureID[material_ids[0]],
138 _process_data.map_materialID_to_fractureID[material_ids[1]]}};
139
140 _process_data.junction_properties.emplace_back(
141 i, *mesh.getNode(vec_junction_nodeID_matIDs[i].first),
143 }
144
145 // create a table of connected junction IDs for each element
146 _process_data.vec_ele_connected_junctionIDs.resize(
147 mesh.getNumberOfElements());
148 for (unsigned i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
149 {
150 auto node = mesh.getNode(vec_junction_nodeID_matIDs[i].first);
151 for (auto id :
152 mesh.getElementsConnectedToNode(*node) | MeshLib::views::ids)
153 {
154 _process_data.vec_ele_connected_junctionIDs[id].push_back(i);
155 }
156 }
157
158 // create a table of junction node and connected elements
161 for (unsigned i = 0; i < vec_junction_nodeID_matIDs.size(); i++)
162 {
163 auto node = mesh.getNode(vec_junction_nodeID_matIDs[i].first);
164 for (auto e : mesh.getElementsConnectedToNode(*node))
165 {
167 const_cast<MeshLib::Element*>(e));
168 }
169 }
170
171 //
172 // If Neumann BCs for the displacement_jump variable are required they
173 // need special treatment because of the levelset function. The
174 // implementation exists in the version 6.1.0
175 // (e54815cc07ee89c81f953a4955b1c788595dd725) and was removed due to
176 // lack of applications.
177 //
178
180 mesh.getProperties().getPropertyVector<int>("MaterialIDs"));
181 _process_data.mesh_prop_materialIDs = material_ids;
182}
#define OGS_FATAL(...)
Definition Error.h:19
void INFO(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:28
std::vector< std::vector< MeshLib::Element * > > _vec_junction_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
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(), MeshLib::Mesh::getNode(), MeshLib::Mesh::getNumberOfElements(), MeshLib::Mesh::getProperties(), MeshLib::Properties::getPropertyVector(), MeshLib::views::ids, INFO(), ProcessLib::Process::name, 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 425 of file LIE/SmallDeformation/SmallDeformationProcess.cpp.

429{
430 DBUG("Assemble SmallDeformationProcess.");
431
434 // Call global assembler for each local assembly item.
438 &b);
439}
void DBUG(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:22
std::vector< std::unique_ptr< LocalAssemblerInterface > > _local_assemblers
std::vector< std::size_t > const & getActiveElementIDs() const
Definition Process.h:160
VectorMatrixAssembler _global_assembler
Definition Process.h:376
std::unique_ptr< NumLib::LocalToGlobalIndexMap > _local_to_global_index_map
Definition Process.h:367
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, ProcessLib::VectorMatrixAssembler::assemble(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberDereferenced(), and ProcessLib::Process::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,
GlobalVector & b,
GlobalMatrix & Jac )
overrideprivatevirtual

◆ 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 402 of file LIE/SmallDeformation/SmallDeformationProcess.cpp.

405{
406 DBUG("Compute the secondary variables for SmallDeformationProcess.");
408 dof_tables.reserve(x.size());
410 [&]() { return _local_to_global_index_map.get(); });
411
415 process_id);
416}
static void executeSelectedMemberOnDereferenced(Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References _local_assemblers, ProcessLib::LocalAssemblerInterface::computeSecondaryVariable(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), and ProcessLib::Process::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 185 of file LIE/SmallDeformation/SmallDeformationProcess.cpp.

186{
187 //------------------------------------------------------------
188 // prepare mesh subsets to define DoFs
189 //------------------------------------------------------------
190 // for extrapolation
193 // regular u
196 // u jump
197 for (unsigned i = 0; i < _vec_fracture_nodes.size(); i++)
198 {
202 }
203 // enrichment for junctions
206
207 // Collect the mesh subsets in a vector.
210 [&]() { return *_mesh_subset_matrix_nodes; });
211 for (auto const& ms : _mesh_subset_fracture_nodes)
212 {
215 [&]() { return *ms; });
216 }
219 [&]() { return *_mesh_subset_junction_nodes; });
220
222 1 + _vec_fracture_mat_IDs.size() + _vec_junction_nodes.size(),
224
227 for (unsigned i = 0; i < _vec_fracture_matrix_elements.size(); i++)
228 {
230 }
231 for (unsigned i = 0; i < _vec_junction_fracture_matrix_elements.size(); i++)
232 {
234 }
235
236 INFO("[LIE/M] creating a DoF table");
243
244 DBUG("[LIE/M] created {:d} DoF", _local_to_global_index_map->size());
245}
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

References ProcessLib::Process::_local_to_global_index_map, ProcessLib::Process::_mesh, ProcessLib::Process::_mesh_subset_all_nodes, _mesh_subset_fracture_nodes, _mesh_subset_junction_nodes, _mesh_subset_matrix_nodes, _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(), and INFO().

◆ 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 296 of file LIE/SmallDeformation/SmallDeformationProcess.cpp.

300{
305 mesh.getElements(), dof_table, _local_assemblers,
306 NumLib::IntegrationOrder{integration_order}, mesh.isAxiallySymmetric(),
308
309 // TODO move the two data members somewhere else.
310 // for extrapolation of secondary variables
316 // by location order is needed for output
318
319 auto add_secondary_variable = [&](std::string const& name,
320 int const num_components,
322 {
323 _secondary_variables.addSecondaryVariable(
324 name,
328 };
329
334
335 add_secondary_variable("epsilon",
339
340 add_secondary_variable("fracture_stress", DisplacementDim,
342
343 add_secondary_variable("fracture_aperture", 1,
345
347 const_cast<MeshLib::Mesh&>(mesh), "sigma_avg",
351
352 for (MeshLib::Element const* e : _mesh.getElements())
353 {
354 if (e->getDimension() < DisplacementDim)
355 {
356 continue;
357 }
358
360 }
361
362 _process_data.element_local_jumps =
364 const_cast<MeshLib::Mesh&>(mesh), "local_jump_w_avg",
366
367 _process_data.element_fracture_stresses =
369 const_cast<MeshLib::Mesh&>(mesh), "fracture_stress_avg",
371
373 const_cast<MeshLib::Mesh&>(mesh), "fracture_aperture_avg",
375
376 mesh_prop_b->resize(mesh.getNumberOfElements());
377 auto const& mesh_prop_matid = *_process_data.mesh_prop_materialIDs;
378 for (auto const& fracture_prop : _process_data.fracture_properties)
379 {
380 for (MeshLib::Element const* e : _mesh.getElements())
381 {
382 if (e->getDimension() == DisplacementDim)
383 {
384 continue;
385 }
386 if (mesh_prop_matid[e->getID()] != fracture_prop.mat_id)
387 {
388 continue;
389 }
390 // Mean value for the element. This allows usage of node based
391 // properties for aperture.
392 (*mesh_prop_b)[e->getID()] =
393 fracture_prop.aperture0
394 .getNodalValuesOnElement(*e, /*time independent*/ 0)
395 .mean();
396 }
397 }
398 _process_data.mesh_prop_b = mesh_prop_b;
399}
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: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, _local_to_global_index_map_single_component, ProcessLib::Process::_mesh, ProcessLib::Process::_mesh_subset_all_nodes, _process_data, ProcessLib::Process::_secondary_variables, NumLib::BY_LOCATION, MeshLib::Cell, ProcessLib::LIE::SmallDeformation::createLocalAssemblers(), MeshLib::Mesh::getElements(), ProcessLib::Process::getExtrapolator(), ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface::getIntPtEpsilon(), ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface::getIntPtFractureAperture(), ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface::getIntPtFractureStress(), ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface::getIntPtSigma(), MeshLib::Mesh::getNumberOfElements(), MeshLib::getOrCreateMeshProperty(), MeshLib::Mesh::isAxiallySymmetric(), ProcessLib::makeExtrapolator(), ProcessLib::Process::name, and updateElementLevelSets().

◆ isLinear()

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

Definition at line 419 of file LIE/SmallDeformation/SmallDeformationProcess.cpp.

420{
421 return false;
422}

◆ 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

◆ updateElementLevelSets()

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

Definition at line 248 of file LIE/SmallDeformation/SmallDeformationProcess.cpp.

250{
254 unsigned tmpi = 0;
255 for (auto fid : _process_data.vec_ele_connected_fractureIDs[e.getID()])
256 {
257 e_fracture_props.push_back(&_process_data.fracture_properties[fid]);
258 e_fracID_to_local.insert({fid, tmpi++});
259 }
262 tmpi = 0;
263 for (auto fid : _process_data.vec_ele_connected_junctionIDs[e.getID()])
264 {
265 e_junction_props.push_back(&_process_data.junction_properties[fid]);
266 e_juncID_to_local.insert({fid, tmpi++});
267 }
270
271 auto update_levelset_property = [&](unsigned const i, int const id,
272 unsigned const levelset_idx_offset,
273 unsigned const name_offset)
274 {
276 const_cast<MeshLib::Mesh&>(mesh),
277 "levelset" + std::to_string(id + 1 + name_offset),
279 levelset_property->resize(mesh.getNumberOfElements());
280 (*levelset_property)[e.getID()] = levelsets[i + levelset_idx_offset];
281 };
282
283 for (unsigned i = 0; i < e_fracture_props.size(); i++)
284 {
286 }
287 for (unsigned i = 0; i < e_junction_props.size(); i++)
288 {
290 e_fracture_props.size(),
291 _process_data.fracture_properties.size());
292 }
293}
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

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

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

Referenced by constructDofTable().

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

Referenced by constructDofTable().

◆ _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 93 of file LIE/SmallDeformation/SmallDeformationProcess.h.

Referenced by constructDofTable().

◆ _process_data

template<int DisplacementDim>
SmallDeformationProcessData<DisplacementDim> ProcessLib::LIE::SmallDeformation::SmallDeformationProcess< DisplacementDim >::_process_data
private

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