https://mooseframework.inl.gov
MortarUtils.h
Go to the documentation of this file.
1 //* This file is part of the MOOSE framework
2 //* https://mooseframework.inl.gov
3 //*
4 //* All rights reserved, see COPYRIGHT for full restrictions
5 //* https://github.com/idaholab/moose/blob/master/COPYRIGHT
6 //*
7 //* Licensed under LGPL 2.1, please see LICENSE for details
8 //* https://www.gnu.org/licenses/lgpl-2.1.html
9 
10 #pragma once
11 
12 #include "Assembly.h"
13 #include "FEProblemBase.h"
14 #include "MaterialBase.h"
15 #include "MaterialWarehouse.h"
17 
18 #include "libmesh/quadrature.h"
19 #include "libmesh/elem.h"
20 #include "libmesh/point.h"
21 
22 namespace Moose
23 {
24 namespace Mortar
25 {
41 void projectQPoints3d(const Elem * msm_elem,
42  const Elem * primal_elem,
43  unsigned int sub_elem_index,
44  const QBase & qrule_msm,
45  std::vector<Point> & q_pts);
46 
68 template <typename Iterators, typename Consumers, typename ActionFunctor>
69 void
71  const Iterators & secondary_elems_to_mortar_segments,
72  Assembly & assembly,
73  SubProblem & subproblem,
74  FEProblemBase & fe_problem,
75  const AutomaticMortarGeneration & amg,
76  const bool displaced,
77  const Consumers & consumers,
78  const THREAD_ID tid,
79  const std::map<SubdomainID, std::deque<MaterialBase *>> & secondary_ip_sub_to_mats,
80  const std::map<SubdomainID, std::deque<MaterialBase *>> & primary_ip_sub_to_mats,
81  const std::deque<MaterialBase *> & secondary_boundary_mats,
82  const ActionFunctor act,
83  const bool reinit_mortar_user_objects)
84 {
85  const auto & primary_secondary_boundary_id_pair = amg.primarySecondaryBoundaryIDPair();
86 
87  const auto primary_boundary_id = primary_secondary_boundary_id_pair.first;
88  const auto secondary_boundary_id = primary_secondary_boundary_id_pair.second;
89 
90  // For 3D mortar get index for retrieving sub-element info
91  unsigned int secondary_sub_elem_index = 0, primary_sub_elem_index = 0;
92  if (amg.dim() == 3)
93  {
94  secondary_sub_elem_index = amg.mortarSegmentMesh().get_elem_integer_index("secondary_sub_elem");
95  primary_sub_elem_index = amg.mortarSegmentMesh().get_elem_integer_index("primary_sub_elem");
96  }
97 
98  // The mortar quadrature rule. Necessary for sizing the number of custom points for re-init'ing
99  // the secondary interior, primary interior, and secondary face elements
100  const auto & qrule_msm = assembly.qRuleMortar();
101 
102  // The element Jacobian times weights
103  const auto & JxW_msm = assembly.jxWMortar();
104 
105  // Set required material properties
106  std::unordered_set<unsigned int> needed_mat_props;
107  for (const auto & consumer : consumers)
108  {
109  const auto & mp_deps = consumer->getMatPropDependencies();
110  needed_mat_props.insert(mp_deps.begin(), mp_deps.end());
111  }
112  fe_problem.setActiveMaterialProperties(needed_mat_props, /*tid=*/tid);
113 
114  // Loop through secondary elements, accumulating quadrature points for all corresponding mortar
115  // segments
116  for (const auto elem_to_msm : secondary_elems_to_mortar_segments)
117  {
118  const Elem * secondary_face_elem = subproblem.mesh().getMesh().elem_ptr(elem_to_msm->first);
119  // Set the secondary interior parent and side ids
120  const Elem * secondary_ip = secondary_face_elem->interior_parent();
121  unsigned int secondary_side_id = secondary_ip->which_side_am_i(secondary_face_elem);
122  const auto & secondary_ip_mats =
123  libmesh_map_find(secondary_ip_sub_to_mats, secondary_ip->subdomain_id());
124 
125  const auto & msm_elems = elem_to_msm->second;
126 
127  // Need to be able to check if there's edge dropping, in 3D we can't just compare
128 
129  // Map mortar segment integration points to primary and secondary sides
130  // Note points for segments will be held contiguously to allow reinit without moving
131  // cleaner way to do this would be with contiguously allocated 2D array but would either
132  // need to move into vector for calling
133  std::vector<Point> secondary_xi_pts, primary_xi_pts;
134 
135  std::vector<Real> JxW;
136 
137 #ifndef NDEBUG
138  unsigned int expected_length = 0;
139 #endif
140 
141  // Loop through contributing msm elements
142  for (const auto msm_elem : msm_elems)
143  {
144  // Initialize mortar segment quadrature and compute JxW
145  subproblem.reinitMortarElem(msm_elem, tid);
146 
147  // Get a reference to the MortarSegmentInfo for this Elem.
148  const MortarSegmentInfo & msinfo = amg.mortarSegmentMeshElemToInfo().at(msm_elem);
149 
150  if (msm_elem->dim() == 1)
151  {
152  for (unsigned int qp = 0; qp < qrule_msm->n_points(); qp++)
153  {
154  const Real eta = qrule_msm->qp(qp)(0);
155 
156  // Map quadrature points to secondary side
157  const Real xi1_eta = 0.5 * (1 - eta) * msinfo.xi1_a + 0.5 * (1 + eta) * msinfo.xi1_b;
158  secondary_xi_pts.push_back(xi1_eta);
159 
160  // Map quadrature points to primary side
161  const Real xi2_eta = 0.5 * (1 - eta) * msinfo.xi2_a + 0.5 * (1 + eta) * msinfo.xi2_b;
162  primary_xi_pts.push_back(xi2_eta);
163  }
164  }
165  else
166  {
167  // Now that has_primary logic gone, could combine these to make more efficient
168  projectQPoints3d(msm_elem,
169  msinfo.secondary_elem,
170  secondary_sub_elem_index,
171  *qrule_msm,
172  secondary_xi_pts);
174  msm_elem, msinfo.primary_elem, primary_sub_elem_index, *qrule_msm, primary_xi_pts);
175  }
176 
177  // If edge dropping case we need JxW on the msm to compute dual shape functions
178  if (assembly.needDual())
179  std::copy(std::begin(JxW_msm), std::end(JxW_msm), std::back_inserter(JxW));
180 
181 #ifndef NDEBUG
182  // Verify that the expected number of quadrature points have been inserted
183  expected_length += qrule_msm->n_points();
184  mooseAssert(secondary_xi_pts.size() == expected_length,
185  "Fewer than expected secondary quadrature points");
186  mooseAssert(primary_xi_pts.size() == expected_length,
187  "Fewer than expected primary quadrature points");
188 
189  if (assembly.needDual())
190  mooseAssert(JxW.size() == expected_length, "Fewer than expected JxW values computed");
191 #endif
192  } // end loop over msm_elems
193 
194  // Reinit dual shape coeffs if dual shape functions needed
195  // lindsayad: is there any need to make sure we do this on both reference and displaced?
196  if (assembly.needDual())
197  assembly.reinitDual(secondary_face_elem, secondary_xi_pts, JxW);
198 
199  unsigned int n_segment = 0;
200 
201  // Loop through contributing msm elements, computing residual and Jacobian this time
202  for (const auto msm_elem : msm_elems)
203  {
204  n_segment++;
205 
206  // These will hold quadrature points for each segment
207  std::vector<Point> xi1_pts, xi2_pts;
208 
209  // Get a reference to the MortarSegmentInfo for this Elem.
210  const MortarSegmentInfo & msinfo = amg.mortarSegmentMeshElemToInfo().at(msm_elem);
211 
212  // Set the primary interior parent and side ids
213  const Elem * primary_ip = msinfo.primary_elem->interior_parent();
214  unsigned int primary_side_id = primary_ip->which_side_am_i(msinfo.primary_elem);
215  const auto & primary_ip_mats =
216  libmesh_map_find(primary_ip_sub_to_mats, primary_ip->subdomain_id());
217 
218  // Compute a JxW for the actual mortar segment element (not the lower dimensional element on
219  // the secondary face!)
220  subproblem.reinitMortarElem(msm_elem, tid);
221 
222  // Extract previously computed mapped quadrature points for secondary and primary face
223  // elements
224  const unsigned int start = (n_segment - 1) * qrule_msm->n_points();
225  const unsigned int end = n_segment * qrule_msm->n_points();
226  xi1_pts.insert(
227  xi1_pts.begin(), secondary_xi_pts.begin() + start, secondary_xi_pts.begin() + end);
228  xi2_pts.insert(xi2_pts.begin(), primary_xi_pts.begin() + start, primary_xi_pts.begin() + end);
229 
230  const Elem * reinit_secondary_elem = secondary_ip;
231 
232  // If we're on the displaced mesh, we need to get the corresponding undisplaced elem before
233  // calling fe_problem.reinitElemFaceRef
234  if (displaced)
235  reinit_secondary_elem = fe_problem.mesh().elemPtr(reinit_secondary_elem->id());
236 
237  // NOTE to future developers: it can be tempting to try and change calls on fe_problem to
238  // calls on subproblem because it seems wasteful to reinit data on both the reference and
239  // displaced problems regardless of whether we are running on a "reference" or displaced
240  // mortar mesh. But making such changes opens a can of worms. For instance, a user may define
241  // constant material properties that are used by mortar constraints and not think about
242  // whether they should set `use_displaced_mesh` for the material (and indeed the user may want
243  // those constant properties usable by both reference and displaced consumer objects). If we
244  // reinit that material and we haven't reinit'd it's assembly member, then we will get things
245  // like segmentation faults. Moreover, one can easily imagine that a material may couple in
246  // variables so we need to make sure those are reinit'd too. So even though it's inefficient,
247  // it's safest to keep making calls on fe_problem instead of subproblem
248 
249  // reinit the variables/residuals/jacobians on the secondary interior
250  fe_problem.reinitElemFaceRef(
251  reinit_secondary_elem, secondary_side_id, TOLERANCE, &xi1_pts, nullptr, tid);
252 
253  const Elem * reinit_primary_elem = primary_ip;
254 
255  // If we're on the displaced mesh, we need to get the corresponding undisplaced elem before
256  // calling fe_problem.reinitElemFaceRef
257  if (displaced)
258  reinit_primary_elem = fe_problem.mesh().elemPtr(reinit_primary_elem->id());
259 
260  // reinit the variables/residuals/jacobians on the primary interior
261  fe_problem.reinitNeighborFaceRef(
262  reinit_primary_elem, primary_side_id, TOLERANCE, &xi2_pts, nullptr, tid);
263 
264  // reinit neighbor materials, but be careful not to execute stateful materials since
265  // conceptually they don't make sense with mortar (they're not interpolary)
266  fe_problem.reinitMaterialsNeighbor(primary_ip->subdomain_id(),
267  /*tid=*/tid,
268  /*swap_stateful=*/false,
269  &primary_ip_mats);
270 
271  // reinit the variables/residuals/jacobians on the lower dimensional element corresponding to
272  // the secondary face. This must be done last after the dof indices have been prepared for the
273  // secondary (element) and primary (neighbor)
274  subproblem.reinitLowerDElem(secondary_face_elem, /*tid=*/tid, &xi1_pts);
275 
276  // All this does currently is sets the neighbor/primary lower dimensional elem in Assembly and
277  // computes its volume for potential use in the MortarConstraints. Solution continuity
278  // stabilization for example relies on being able to access the volume
279  subproblem.reinitNeighborLowerDElem(msinfo.primary_elem, tid);
280 
281  // reinit higher-dimensional secondary face/boundary materials. Do this after we reinit
282  // lower-d variables in case we want to pull the lower-d variable values into the secondary
283  // face/boundary materials. Be careful not to execute stateful materials since conceptually
284  // they don't make sense with mortar (they're not interpolary)
285  fe_problem.reinitMaterialsFace(secondary_ip->subdomain_id(),
286  /*tid=*/tid,
287  /*swap_stateful=*/false,
288  &secondary_ip_mats);
289  fe_problem.reinitMaterialsBoundary(
290  secondary_boundary_id, /*tid=*/tid, /*swap_stateful=*/false, &secondary_boundary_mats);
291 
292  if (reinit_mortar_user_objects)
293  fe_problem.reinitMortarUserObjects(primary_boundary_id, secondary_boundary_id, displaced);
294 
295  act();
296 
297  } // End loop over msm segments on secondary face elem
298  } // End loop over (active) secondary elems
299 }
300 
315 template <typename Consumers>
316 void
317 setupMortarMaterials(const Consumers & consumers,
318  FEProblemBase & fe_problem,
319  const AutomaticMortarGeneration & amg,
320  const THREAD_ID tid,
321  std::map<SubdomainID, std::deque<MaterialBase *>> & secondary_ip_sub_to_mats,
322  std::map<SubdomainID, std::deque<MaterialBase *>> & primary_ip_sub_to_mats,
323  std::deque<MaterialBase *> & secondary_boundary_mats)
324 {
325  secondary_ip_sub_to_mats.clear();
326  primary_ip_sub_to_mats.clear();
327  secondary_boundary_mats.clear();
328 
329  auto & mat_warehouse = fe_problem.getRegularMaterialsWarehouse();
330  auto get_required_sub_mats =
331  [&mat_warehouse, tid, &consumers](
332  const SubdomainID sub_id,
333  const Moose::MaterialDataType mat_data_type) -> std::deque<MaterialBase *>
334  {
335  if (mat_warehouse[mat_data_type].hasActiveBlockObjects(sub_id, tid))
336  {
337  auto & sub_mats = mat_warehouse[mat_data_type].getActiveBlockObjects(sub_id, tid);
338  return MaterialBase::buildRequiredMaterials(consumers, sub_mats, /*allow_stateful=*/false);
339  }
340  else
341  return {};
342  };
343 
344  // Construct secondary *block* materials container
345  const auto & secondary_ip_sub_ids = amg.secondaryIPSubIDs();
346  for (const auto secondary_ip_sub : secondary_ip_sub_ids)
347  secondary_ip_sub_to_mats.emplace(
348  secondary_ip_sub, get_required_sub_mats(secondary_ip_sub, Moose::FACE_MATERIAL_DATA));
349 
350  // Construct primary *block* materials container
351  const auto & primary_ip_sub_ids = amg.primaryIPSubIDs();
352  for (const auto primary_ip_sub : primary_ip_sub_ids)
353  primary_ip_sub_to_mats.emplace(
354  primary_ip_sub, get_required_sub_mats(primary_ip_sub, Moose::NEIGHBOR_MATERIAL_DATA));
355 
356  // Construct secondary *boundary* materials container
357  const auto & boundary_pr = amg.primarySecondaryBoundaryIDPair();
358  const auto secondary_boundary = boundary_pr.second;
359  if (mat_warehouse.hasActiveBoundaryObjects(secondary_boundary, tid))
360  {
361  auto & boundary_mats = mat_warehouse.getActiveBoundaryObjects(secondary_boundary, tid);
362  secondary_boundary_mats =
363  MaterialBase::buildRequiredMaterials(consumers, boundary_mats, /*allow_stateful=*/false);
364  }
365 }
366 }
367 }
virtual MooseMesh & mesh()=0
void setActiveMaterialProperties(const std::unordered_set< unsigned int > &mat_prop_ids, const THREAD_ID tid)
Record and set the material properties required by the current computing thread.
void reinitNeighborLowerDElem(const Elem *elem, const THREAD_ID tid=0)
reinitialize a neighboring lower dimensional element
Definition: SubProblem.C:988
const std::pair< BoundaryID, BoundaryID > & primarySecondaryBoundaryIDPair() const
virtual void reinitLowerDElem(const Elem *lower_d_elem, const THREAD_ID tid, const std::vector< Point > *const pts=nullptr, const std::vector< Real > *const weights=nullptr)
Definition: SubProblem.C:958
Keeps track of stuff related to assembling.
Definition: Assembly.h:109
const std::map< SubdomainID, std::vector< std::shared_ptr< T > > > & getActiveBlockObjects(THREAD_ID tid=0) const
virtual Elem * elemPtr(const dof_id_type i)
Definition: MooseMesh.C:3193
void setupMortarMaterials(const Consumers &consumers, FEProblemBase &fe_problem, const AutomaticMortarGeneration &amg, const THREAD_ID tid, std::map< SubdomainID, std::deque< MaterialBase *>> &secondary_ip_sub_to_mats, std::map< SubdomainID, std::deque< MaterialBase *>> &primary_ip_sub_to_mats, std::deque< MaterialBase *> &secondary_boundary_mats)
This function creates containers of materials necessary to execute the mortar method for a supplied s...
Definition: MortarUtils.h:317
MaterialDataType
MaterialData types.
Definition: MooseTypes.h:740
void reinitMortarUserObjects(BoundaryID primary_boundary_id, BoundaryID secondary_boundary_id, bool displaced)
Call reinit on mortar user objects with matching primary boundary ID, secondary boundary ID...
void reinitMaterialsBoundary(BoundaryID boundary_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr)
reinit materials on a boundary
const libMesh::QBase *const & qRuleMortar() const
Returns a reference to the quadrature rule for the mortar segments.
Definition: Assembly.h:712
const std::set< SubdomainID > & primaryIPSubIDs() const
Specialization of SubProblem for solving nonlinear equations plus auxiliary equations.
const MaterialWarehouse & getRegularMaterialsWarehouse() const
void reinitMaterialsFace(SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr)
reinit materials on element faces
const std::set< SubdomainID > & secondaryIPSubIDs() const
This class is a container/interface for the objects involved in automatic generation of mortar spaces...
virtual void reinitElemFaceRef(const Elem *elem, unsigned int side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0) override
reinitialize FE objects on a given element on a given side at a given set of reference points and the...
const Elem * primary_elem
bool needDual() const
Indicates whether dual shape functions are used (computation is now repeated on each element so expen...
Definition: Assembly.h:623
MeshBase & getMesh()
Accessor for the underlying libMesh Mesh object.
Definition: MooseMesh.C:3528
void reinitMaterialsNeighbor(SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr)
reinit materials on the neighboring element face
virtual void reinitNeighborFaceRef(const Elem *neighbor_elem, unsigned int neighbor_side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0) override
reinitialize FE objects on a given neighbor element on a given side at a given set of reference point...
void loopOverMortarSegments(const Iterators &secondary_elems_to_mortar_segments, Assembly &assembly, SubProblem &subproblem, FEProblemBase &fe_problem, const AutomaticMortarGeneration &amg, const bool displaced, const Consumers &consumers, const THREAD_ID tid, const std::map< SubdomainID, std::deque< MaterialBase *>> &secondary_ip_sub_to_mats, const std::map< SubdomainID, std::deque< MaterialBase *>> &primary_ip_sub_to_mats, const std::deque< MaterialBase *> &secondary_boundary_mats, const ActionFunctor act, const bool reinit_mortar_user_objects)
This method will loop over pairs of secondary elements and their corresponding mortar segments...
Definition: MortarUtils.h:70
const Elem * secondary_elem
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
Holds xi^(1), xi^(2), and other data for a given mortar segment.
Generic class for solving transient nonlinear problems.
Definition: SubProblem.h:78
static std::deque< MaterialBase * > buildRequiredMaterials(const Consumers &mat_consumers, const std::vector< std::shared_ptr< MaterialBase >> &mats, const bool allow_stateful)
Build the materials required by a set of consumer objects.
Definition: MaterialBase.h:534
const std::unordered_map< const Elem *, MortarSegmentInfo > & mortarSegmentMeshElemToInfo() const
virtual MooseMesh & mesh() override
const MeshBase & mortarSegmentMesh() const
MOOSE now contains C++17 code, so give a reasonable error message stating what the user can do to add...
const std::vector< Real > & jxWMortar() const
Returns a reference to JxW for mortar segment elements.
Definition: Assembly.h:707
void reinitMortarElem(const Elem *elem, const THREAD_ID tid=0)
Reinit a mortar element to obtain a valid JxW.
Definition: SubProblem.C:995
unsigned int THREAD_ID
Definition: MooseTypes.h:237
void projectQPoints3d(const Elem *msm_elem, const Elem *primal_elem, unsigned int sub_elem_index, const QBase &qrule_msm, std::vector< Point > &q_pts)
3D projection operator for mapping qpoints on mortar segments to secondary or primary elements ...
Definition: MortarUtils.C:26
void reinitDual(const Elem *elem, const std::vector< Point > &pts, const std::vector< Real > &JxW)
Reintialize dual basis coefficients based on a customized quadrature rule.
Definition: Assembly.C:2272