v0.15.0
Loading...
Searching...
No Matches
EshelbianCore.hpp
Go to the documentation of this file.
1/**
2 * @file EshelbianCore.hpp
3 * @author your name (you@domain.com)
4 * @brief
5 * @version 0.1
6 * @date 2024-12-31
7 *
8 * @copyright Copyright (c) 2024
9 *
10 */
11
13
21
23 static inline enum SymmetrySelector symmetrySelector = NOT_SYMMETRIC;
24 static inline enum RotSelector rotSelector = LARGE_ROT;
25 static inline enum RotSelector gradApproximator = LARGE_ROT;
26 static inline enum StretchSelector stretchSelector = LOG;
27 static inline PetscBool noStretch = PETSC_FALSE; //< no stretch field
28 static inline PetscBool setSingularity = PETSC_FALSE; //< set singularity
29 static inline PetscBool dynamicRelaxation =
30 PETSC_FALSE; //< switch on/off dynamic relaxation
31 static inline PetscBool crackingOn = PETSC_FALSE; //< cracking on
32 static inline double crackingStartTime = 0; //< time when crack starts to grow
33 static inline int nbJIntegralContours =
34 0; //< number of contours for J integral evaluation
35 static inline double dynamicTime =
36 0; //< true time used when dynamic relaxation is used.
37 static inline int dynamicStep =
38 0; //< true time used when dynamic relaxation is used.
39 static inline PetscBool l2UserBaseScale = PETSC_TRUE; //< scale L2 user base
40 static inline int addCrackMeshsetId = 1000; //< add crack meshset id
41 static inline double griffithEnergy = 1; ///< Griffith energy
42 static inline enum EnergyReleaseSelector energyReleaseSelector =
43 GRIFFITH_SKELETON; //< energy release selector
44 static inline std::string internalStressTagName =
45 ""; //< internal stress tag name
46 static inline int internalStressInterpOrder =
47 1; //< internal stress interpolation order
48 static inline PetscBool internalStressVoigt =
49 PETSC_FALSE; //< internal stress index notation
50
51 static double exponentBase;
52 static boost::function<double(const double)> f;
53 static boost::function<double(const double)> d_f;
54 static boost::function<double(const double)> dd_f;
55 static boost::function<double(const double)> inv_f;
56 static boost::function<double(const double)> inv_d_f;
57 static boost::function<double(const double)> inv_dd_f;
58
59 static inline constexpr bool use_quadratic_exp = true;
60 static inline constexpr double v_max = 12;
61 static inline constexpr double v_min = -v_max;
62
63 static double f_log_e_quadratic(const double v) {
64 if (v > v_max) {
65 double e = static_cast<double>(std::exp(v_max));
66 double dv = v - v_max;
67 return 0.5 * e * dv * dv + e * dv + e;
68 } else {
69 return static_cast<double>(std::exp(v));
70 }
71 }
72
73 static double d_f_log_e_quadratic(const double v) {
74 if (v > v_max) {
75 double e = static_cast<double>(std::exp(v_max));
76 double dv = v - v_max;
77 return e * dv + e;
78 } else {
79 return static_cast<double>(std::exp(v));
80 }
81 }
82
83 static double dd_f_log_e_quadratic(const double v) {
84 if (v > v_max) {
85 return static_cast<double>(std::exp(v_max));
86 } else {
87 return static_cast<double>(std::exp(v));
88 }
89 }
90
91 static double f_log_e(const double v) {
92 if constexpr(use_quadratic_exp) {
93 return f_log_e_quadratic(v);
94 } else {
95 if (v > v_max)
96 // y = exp(v_max) * v + exp(v_max) * (1 - v_max);
97 // y/exp(v_max) = v + (1 - v_max);
98 // y/exp(v_max) - (1 - v_max) = v;
99 return std::exp(v_max) * v + std::exp(v_max) * (1 - v_max);
100 else
101 return std::exp(v);
102 }
103 }
104 static double d_f_log_e(const double v) {
105 if constexpr (use_quadratic_exp) {
106 return d_f_log_e_quadratic(v);
107 } else {
108 if (v > v_max)
109 return std::exp(v_max);
110 else
111 return std::exp(v);
112 }
113 }
114 static double dd_f_log_e(const double v) {
115 if constexpr (use_quadratic_exp) {
116 return dd_f_log_e_quadratic(v);
117 } else {
118 if (v > v_max)
119 return 0.;
120 else
121 return std::exp(v);
122 }
123 }
124 static double inv_f_log_e(const double v) {
125 if (v > std::exp(v_min))
126 return std::log(v);
127 else
128 // y = exp(v_min) * v + exp(v_min) * (1 - v_min);
129 // y/exp(v_min) = v + (1 - v_min);
130 // y/exp(v_min) - (1 - v_min) = v;
131 return v / exp(v_min) - (1 - v_min);
132 }
133 static double inv_d_f_log_e(const double v) {
134 if (v > std::exp(v_min))
135 return 1. / v;
136 else
137 return 1. / exp(v_min);
138 }
139 static double inv_dd_f_log_e(const double v) {
140 if (v > std::exp(v_min))
141 return -1. / (v * v);
142 else
143 return 0.;
144 }
145
146 static double f_log(const double v) {
147 return pow(EshelbianCore::exponentBase, v);
148 }
149 static double d_f_log(const double v) {
150 return pow(exponentBase, v) * log(EshelbianCore::exponentBase);
151 }
152 static double dd_f_log(const double v) {
153 return pow(EshelbianCore::exponentBase, v) *
155 }
156
157 static double inv_f_log(const double v) {
158 return log(v) / log(EshelbianCore::exponentBase);
159 }
160 static double inv_d_f_log(const double v) {
161 return (1. / v) / log(EshelbianCore::exponentBase);
162 }
163 static double inv_dd_f_log(const double v) {
164 return -(1. / (v * v)) / log(EshelbianCore::exponentBase);
165 }
166
167 static double f_linear(const double v) { return v + 1; }
168 static double d_f_linear(const double v) { return 1; }
169 static double dd_f_linear(const double v) { return 0; }
170
171 static double inv_f_linear(const double v) { return v - 1; }
172 static double inv_d_f_linear(const double v) { return 0; }
173 static double inv_dd_f_linear(const double v) { return 0; }
174
175 /**
176 * \brief Getting interface of core database
177 * @param uuid unique ID of interface
178 * @param iface returned pointer to interface
179 * @return error code
180 */
181 MoFEMErrorCode query_interface(boost::typeindex::type_index type_index,
182 UnknownInterface **iface) const;
183
185
186 boost::shared_ptr<DataAtIntegrationPts> dataAtPts;
187 boost::shared_ptr<PhysicalEquations> physicalEquations;
188 boost::shared_ptr<AnalyticalExprPython> AnalyticalExprPythonPtr;
189
190 boost::shared_ptr<VolumeElementForcesAndSourcesCore> elasticFeRhs;
191 boost::shared_ptr<VolumeElementForcesAndSourcesCore> elasticFeLhs;
192 boost::shared_ptr<FaceElementForcesAndSourcesCore> elasticBcLhs;
193 boost::shared_ptr<FaceElementForcesAndSourcesCore> elasticBcRhs;
194 boost::shared_ptr<ContactTree> contactTreeRhs; ///< Make a contact tree
195
196 SmartPetscObj<DM> dM; ///< Coupled problem all fields
197 SmartPetscObj<DM> dmElastic; ///< Elastic problem
198 SmartPetscObj<DM> dmMaterial; ///< Material problem
199 SmartPetscObj<DM> dmPrjSpatial; ///< Projection spatial displacement
200
201 const std::string piolaStress = "P";
202 // const std::string eshelbyStress = "S";
203 const std::string spatialL2Disp = "wL2";
204 // const std::string materialL2Disp = "WL2";
205 const std::string spatialH1Disp = "wH1";
206 const std::string materialH1Positions = "XH1";
207 const std::string hybridSpatialDisp = "hybridSpatialDisp";
208 // const std::string hybridMaterialDisp = "hybridMaterialDisp";
209 const std::string contactDisp = "contactDisp";
210 const std::string stretchTensor = "u";
211 const std::string rotAxis = "omega";
212 const std::string bubbleField = "bubble";
213
214 const std::string elementVolumeName = "EP";
215 const std::string naturalBcElement = "NATURAL_BC";
216 const std::string skinElement = "SKIN";
217 const std::string skeletonElement = "SKELETON";
218 const std::string contactElement = "CONTACT";
219
221 virtual ~EshelbianCore();
222
223 int spaceOrder = 2;
224 int spaceH1Order = -1;
226 double alphaU = 0;
227 double alphaW = 0;
228 double alphaOmega = 0;
229 double alphaRho = 0;
230 double alphaTau = 0;
231
232 int contactRefinementLevels = 1; //< refinement levels for contact integration
233 int frontLayers = 3; //< front layers with material element
234
235 MoFEMErrorCode getOptions();
236
237 boost::shared_ptr<BcDispVec> bcSpatialDispVecPtr;
238 boost::shared_ptr<BcRotVec> bcSpatialRotationVecPtr;
239 boost::shared_ptr<TractionBcVec> bcSpatialTractionVecPtr;
240 boost::shared_ptr<TractionFreeBc> bcSpatialFreeTractionVecPtr;
241 boost::shared_ptr<NormalDisplacementBcVec> bcSpatialNormalDisplacementVecPtr;
242 boost::shared_ptr<AnalyticalDisplacementBcVec>
244 boost::shared_ptr<AnalyticalTractionBcVec> bcSpatialAnalyticalTractionVecPtr;
245 boost::shared_ptr<PressureBcVec> bcSpatialPressureVecPtr;
246 boost::shared_ptr<ExternalStrainVec> externalStrainVecPtr;
247
248 std::map<std::string, boost::shared_ptr<ScalingMethod>> timeScaleMap;
249
250 template <typename BC>
251 MoFEMErrorCode getBc(boost::shared_ptr<BC> &bc_vec_ptr,
252 const std::string block_name, const int nb_attributes) {
254 for (auto it :
255 mField.getInterface<MeshsetsManager>()->getCubitMeshsetPtr(std::regex(
256
257 (boost::format("%s(.*)") % block_name).str()
258
259 ))
260
261 ) {
262 std::vector<double> block_attributes;
263 CHKERR it->getAttributes(block_attributes);
264 if (block_attributes.size() < nb_attributes) {
265 SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
266 "In block %s expected %d attributes, but given %ld",
267 it->getName().c_str(), nb_attributes, block_attributes.size());
268 }
269 Range faces;
270 CHKERR it->getMeshsetIdEntitiesByDimension(mField.get_moab(), 2, faces,
271 true);
272 bc_vec_ptr->emplace_back(it->getName(), block_attributes, faces);
273 }
275 }
276
277 MoFEMErrorCode getSpatialDispBc();
278
279 inline MoFEMErrorCode getSpatialRotationBc() {
281 bcSpatialRotationVecPtr = boost::make_shared<BcRotVec>();
282 CHKERR getBc(bcSpatialRotationVecPtr, "SPATIAL_ROTATION_BC", 4);
283 CHKERR getBc(bcSpatialRotationVecPtr, "SPATIAL_ROTATION_AXIS_BC", 7);
284
285 auto ts_rotation =
286 boost::make_shared<DynamicRelaxationTimeScale>("rotation_history.txt");
287 for (auto &bc : *bcSpatialRotationVecPtr) {
288 timeScaleMap[bc.blockName] =
289 GetBlockScalingMethod<DynamicRelaxationTimeScale>::get(
290 ts_rotation, "rotation_history", ".txt", bc.blockName);
291 }
292
294 }
295
296 MoFEMErrorCode getSpatialTractionBc();
297
298 /**
299 * @brief Remove all, but entities where kinematic constrains are applied.
300 *
301 * @param meshset
302 * @param bc_ptr
303 * @param disp_block_set_name
304 * @param rot_block_set_name
305 * @param contact_set_name
306 * @return MoFEMErrorCode
307 */
308 MoFEMErrorCode getTractionFreeBc(const EntityHandle meshset,
309 boost::shared_ptr<TractionFreeBc> &bc_ptr,
310 const std::string contact_set_name);
311
312 inline MoFEMErrorCode
315 boost::shared_ptr<TractionFreeBc>(new TractionFreeBc());
316 return getTractionFreeBc(meshset, bcSpatialFreeTractionVecPtr, "CONTACT");
317 }
318
319 MoFEMErrorCode getExternalStrain();
320
321 MoFEMErrorCode createExchangeVectors(Sev sev);
322
323 MoFEMErrorCode addFields(const EntityHandle meshset = 0);
324 MoFEMErrorCode projectGeometry(const EntityHandle meshset = 0);
325
326 MoFEMErrorCode addVolumeFiniteElement(const EntityHandle meshset = 0);
327 MoFEMErrorCode addBoundaryFiniteElement(const EntityHandle meshset = 0);
328 MoFEMErrorCode addDMs(const BitRefLevel bit = BitRefLevel().set(0),
329 const EntityHandle meshset = 0);
330
331 MoFEMErrorCode addMaterial_HMHHStVenantKirchhoff(const int tape,
332 const double lambda,
333 const double mu,
334 const double sigma_y);
335
336 MoFEMErrorCode addMaterial_HMHMooneyRivlin(const int tape, const double alpha,
337 const double beta,
338 const double lambda,
339 const double sigma_y);
340
341 MoFEMErrorCode addMaterial_HMHNeohookean(const int tape, const double c10,
342 const double K);
343
344 MoFEMErrorCode addMaterial_Hencky(double E, double nu);
345
346 MoFEMErrorCode setBaseVolumeElementOps(
347 const int tag, const bool do_rhs, const bool do_lhs,
348 const bool calc_rates, SmartPetscObj<Vec> ver_vec,
349 boost::shared_ptr<VolumeElementForcesAndSourcesCore> fe);
350
351 MoFEMErrorCode setVolumeElementOps(
352 const int tag, const bool add_elastic, const bool add_material,
353 boost::shared_ptr<VolumeElementForcesAndSourcesCore> &fe_rhs,
354 boost::shared_ptr<VolumeElementForcesAndSourcesCore> &fe_lhs);
355
356 MoFEMErrorCode
357 setFaceElementOps(const bool add_elastic, const bool add_material,
358 boost::shared_ptr<FaceElementForcesAndSourcesCore> &fe_rhs,
359 boost::shared_ptr<FaceElementForcesAndSourcesCore> &fe_lhs);
360
361 MoFEMErrorCode setContactElementRhsOps(
362
363 boost::shared_ptr<ContactTree> &fe_contact_tree
364
365 );
366
367 MoFEMErrorCode setElasticElementOps(const int tag);
368 MoFEMErrorCode setElasticElementToTs(DM dm);
369
370 friend struct solve_elastic_set_up;
371 MoFEMErrorCode solveElastic(TS ts, Vec x);
372
373 /**
374 * @brief Solve problem using dynamic relaxation method
375 *
376 * @param ts solver time stepper
377 * @param x solution vector
378 * @param start_step starting step number
379 * @param start_time starting time
380 * @return MoFEMErrorCode
381 */
382 MoFEMErrorCode solveDynamicRelaxation(TS ts, Vec x, int start_step,
383 double start_time);
384
385 MoFEMErrorCode setBlockTagsOnSkin();
386
387 MoFEMErrorCode postProcessResults(const int tag, const std::string file,
388 Vec f_residual = PETSC_NULLPTR,
389 Vec var_vec = PETSC_NULLPTR,
390 std::vector<Tag> tags_to_transfer = {});
391 MoFEMErrorCode
392 postProcessSkeletonResults(const int tag, const std::string file,
393 Vec f_residual = PETSC_NULLPTR,
394 std::vector<Tag> tags_to_transfer = {});
395
397 boost::shared_ptr<double> area_ptr); // calculate crack area
398
400
401 struct SetUpSchur {
402 static boost::shared_ptr<SetUpSchur> createSetUpSchur(
403
404 MoFEM::Interface &m_field, EshelbianCore *ep_core_ptr
405
406 );
407 virtual MoFEMErrorCode setUp(TS) = 0;
408
409 protected:
410 SetUpSchur() = default;
411 };
412
414
415 using TimeScale::TimeScale;
416
417 double getScale(const double time) override {
419 return TimeScale::getScale(EshelbianCore::dynamicTime);
420 } else {
421 return TimeScale::getScale(time);
422 }
423 }
424 };
425
426 MoFEMErrorCode calculateFaceMaterialForce(const int tag, TS ts);
427 MoFEMErrorCode calculateOrientation(const int tag, bool set_orientation);
428 MoFEMErrorCode setNewFrontCoordinates();
429 MoFEMErrorCode addCrackSurfaces(const bool debug = false);
430 MoFEMErrorCode saveOrgCoords();
431 MoFEMErrorCode createCrackSurfaceMeshset();
432
433 boost::shared_ptr<Range> contactFaces;
434 boost::shared_ptr<Range> crackFaces;
435 boost::shared_ptr<Range> frontEdges;
436 boost::shared_ptr<Range> frontAdjEdges;
437 boost::shared_ptr<Range> frontVertices;
438 boost::shared_ptr<Range> skeletonFaces;
439 boost::shared_ptr<Range> maxMovedFaces;
440
441 boost::shared_ptr<ParentFiniteElementAdjacencyFunctionSkeleton<2>>
443
444 BitRefLevel bitAdjParent = BitRefLevel().set(); ///< bit ref level for parent
445 BitRefLevel bitAdjParentMask =
446 BitRefLevel().set(); ///< bit ref level for parent parent
447 BitRefLevel bitAdjEnt = BitRefLevel().set(); ///< bit ref level for parent
448 BitRefLevel bitAdjEntMask =
449 BitRefLevel().set(); ///< bit ref level for parent parent
450
451 SmartPetscObj<Vec> solTSStep;
452
453 CommInterface::EntitiesPetscVector volumeExchange;
454 CommInterface::EntitiesPetscVector faceExchange;
455 CommInterface::EntitiesPetscVector edgeExchange;
456 CommInterface::EntitiesPetscVector vertexExchange;
457
458 std::vector<Tag>
459 listTagsToTransfer; ///< list of tags to transfer to postprocessor
460
461 Mat S = PETSC_NULLPTR; //< Schur complement matrix
462 AO aoS = PETSC_NULLPTR; //< AO for Schur complement matrix
463 SmartPetscObj<IS> crackHybridIs; //< IS for crack hybrid field
464 std::vector<std::string> a00FieldList; //< list of fields for Schur complement
465 std::vector<boost::shared_ptr<Range>>
466 a00RangeList; //< list of ranges for Schur complement
467
468 int nbCrackFaces = 0; //< number of crack faces
469};
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
@ MOFEM_DATA_INCONSISTENCY
Definition definitions.h:31
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
#define CHKERR
Inline error check.
static const bool debug
auto bit
set bit
static double lambda
const double v
phase velocity of light in medium (cm/ns)
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
double getScale(const double time) override
virtual MoFEMErrorCode setUp(TS)=0
static boost::shared_ptr< SetUpSchur > createSetUpSchur(MoFEM::Interface &m_field, EshelbianCore *ep_core_ptr)
std::vector< boost::shared_ptr< Range > > a00RangeList
MoFEMErrorCode setElasticElementOps(const int tag)
boost::shared_ptr< ExternalStrainVec > externalStrainVecPtr
MoFEMErrorCode addVolumeFiniteElement(const EntityHandle meshset=0)
MoFEMErrorCode addFields(const EntityHandle meshset=0)
static constexpr bool use_quadratic_exp
static enum StretchSelector stretchSelector
boost::shared_ptr< Range > frontAdjEdges
MoFEMErrorCode createCrackSurfaceMeshset()
MoFEMErrorCode addBoundaryFiniteElement(const EntityHandle meshset=0)
const std::string skeletonElement
static double inv_f_linear(const double v)
MoFEMErrorCode getSpatialRotationBc()
boost::shared_ptr< TractionBcVec > bcSpatialTractionVecPtr
boost::shared_ptr< Range > contactFaces
static double dd_f_log_e_quadratic(const double v)
static double dynamicTime
static double dd_f_log(const double v)
BitRefLevel bitAdjEnt
bit ref level for parent
static boost::function< double(const double)> inv_dd_f
MoFEM::Interface & mField
static constexpr double v_max
const std::string spatialL2Disp
static double inv_d_f_log(const double v)
std::map< std::string, boost::shared_ptr< ScalingMethod > > timeScaleMap
MoFEMErrorCode addMaterial_Hencky(double E, double nu)
friend struct solve_elastic_set_up
static PetscBool l2UserBaseScale
SmartPetscObj< DM > dM
Coupled problem all fields.
boost::shared_ptr< FaceElementForcesAndSourcesCore > elasticBcRhs
static int internalStressInterpOrder
SmartPetscObj< IS > crackHybridIs
MoFEMErrorCode projectGeometry(const EntityHandle meshset=0)
boost::shared_ptr< TractionFreeBc > bcSpatialFreeTractionVecPtr
const std::string materialH1Positions
static int nbJIntegralContours
MoFEMErrorCode setBlockTagsOnSkin()
std::vector< Tag > listTagsToTransfer
list of tags to transfer to postprocessor
boost::shared_ptr< FaceElementForcesAndSourcesCore > elasticBcLhs
static PetscBool crackingOn
MoFEMErrorCode addMaterial_HMHHStVenantKirchhoff(const int tape, const double lambda, const double mu, const double sigma_y)
MoFEMErrorCode addMaterial_HMHMooneyRivlin(const int tape, const double alpha, const double beta, const double lambda, const double sigma_y)
MoFEMErrorCode getTractionFreeBc(const EntityHandle meshset, boost::shared_ptr< TractionFreeBc > &bc_ptr, const std::string contact_set_name)
Remove all, but entities where kinematic constrains are applied.
MoFEMErrorCode setBaseVolumeElementOps(const int tag, const bool do_rhs, const bool do_lhs, const bool calc_rates, SmartPetscObj< Vec > ver_vec, boost::shared_ptr< VolumeElementForcesAndSourcesCore > fe)
MoFEMErrorCode calculateFaceMaterialForce(const int tag, TS ts)
static double griffithEnergy
Griffith energy.
MoFEMErrorCode calculateCrackArea(boost::shared_ptr< double > area_ptr)
boost::shared_ptr< VolumeElementForcesAndSourcesCore > elasticFeRhs
static int dynamicStep
const std::string elementVolumeName
static double dd_f_log_e(const double v)
static enum RotSelector rotSelector
static enum RotSelector gradApproximator
MoFEMErrorCode getBc(boost::shared_ptr< BC > &bc_vec_ptr, const std::string block_name, const int nb_attributes)
CommInterface::EntitiesPetscVector vertexExchange
boost::shared_ptr< BcRotVec > bcSpatialRotationVecPtr
boost::shared_ptr< Range > maxMovedFaces
static PetscBool dynamicRelaxation
const std::string spatialH1Disp
MoFEMErrorCode solveElastic(TS ts, Vec x)
static double d_f_log(const double v)
boost::shared_ptr< NormalDisplacementBcVec > bcSpatialNormalDisplacementVecPtr
static double crackingStartTime
static enum MaterialModel materialModel
MoFEMErrorCode getOptions()
const std::string piolaStress
MoFEMErrorCode setElasticElementToTs(DM dm)
static double inv_d_f_log_e(const double v)
MoFEMErrorCode gettingNorms()
[Getting norms]
std::vector< std::string > a00FieldList
MoFEMErrorCode setVolumeElementOps(const int tag, const bool add_elastic, const bool add_material, boost::shared_ptr< VolumeElementForcesAndSourcesCore > &fe_rhs, boost::shared_ptr< VolumeElementForcesAndSourcesCore > &fe_lhs)
MoFEMErrorCode query_interface(boost::typeindex::type_index type_index, UnknownInterface **iface) const
Getting interface of core database.
const std::string bubbleField
boost::shared_ptr< AnalyticalDisplacementBcVec > bcSpatialAnalyticalDisplacementVecPtr
SmartPetscObj< DM > dmMaterial
Material problem.
MoFEMErrorCode calculateOrientation(const int tag, bool set_orientation)
static double inv_f_log(const double v)
boost::shared_ptr< VolumeElementForcesAndSourcesCore > elasticFeLhs
static PetscBool noStretch
MoFEMErrorCode setNewFrontCoordinates()
boost::shared_ptr< ParentFiniteElementAdjacencyFunctionSkeleton< 2 > > parentAdjSkeletonFunctionDim2
boost::shared_ptr< ContactTree > contactTreeRhs
Make a contact tree.
static double exponentBase
MoFEMErrorCode setContactElementRhsOps(boost::shared_ptr< ContactTree > &fe_contact_tree)
static double dd_f_linear(const double v)
MoFEMErrorCode setFaceElementOps(const bool add_elastic, const bool add_material, boost::shared_ptr< FaceElementForcesAndSourcesCore > &fe_rhs, boost::shared_ptr< FaceElementForcesAndSourcesCore > &fe_lhs)
MoFEMErrorCode postProcessSkeletonResults(const int tag, const std::string file, Vec f_residual=PETSC_NULLPTR, std::vector< Tag > tags_to_transfer={})
boost::shared_ptr< AnalyticalExprPython > AnalyticalExprPythonPtr
boost::shared_ptr< Range > skeletonFaces
boost::shared_ptr< PhysicalEquations > physicalEquations
const std::string rotAxis
static double inv_d_f_linear(const double v)
BitRefLevel bitAdjParentMask
bit ref level for parent parent
MoFEMErrorCode solveDynamicRelaxation(TS ts, Vec x, int start_step, double start_time)
Solve problem using dynamic relaxation method.
static double inv_dd_f_log(const double v)
const std::string contactDisp
static std::string internalStressTagName
static enum SymmetrySelector symmetrySelector
CommInterface::EntitiesPetscVector edgeExchange
SmartPetscObj< DM > dmPrjSpatial
Projection spatial displacement.
static boost::function< double(const double)> f
boost::shared_ptr< BcDispVec > bcSpatialDispVecPtr
const std::string skinElement
static PetscBool internalStressVoigt
static double inv_dd_f_linear(const double v)
MoFEMErrorCode getSpatialTractionFreeBc(const EntityHandle meshset=0)
static double inv_dd_f_log_e(const double v)
MoFEMErrorCode getExternalStrain()
MoFEMErrorCode getSpatialTractionBc()
static PetscBool setSingularity
virtual ~EshelbianCore()
static double d_f_log_e(const double v)
boost::shared_ptr< AnalyticalTractionBcVec > bcSpatialAnalyticalTractionVecPtr
static double f_log_e_quadratic(const double v)
MoFEMErrorCode addCrackSurfaces(const bool debug=false)
MoFEMErrorCode addDMs(const BitRefLevel bit=BitRefLevel().set(0), const EntityHandle meshset=0)
MoFEMErrorCode getSpatialDispBc()
[Getting norms]
BitRefLevel bitAdjParent
bit ref level for parent
MoFEMErrorCode postProcessResults(const int tag, const std::string file, Vec f_residual=PETSC_NULLPTR, Vec var_vec=PETSC_NULLPTR, std::vector< Tag > tags_to_transfer={})
static double d_f_log_e_quadratic(const double v)
CommInterface::EntitiesPetscVector volumeExchange
MoFEMErrorCode saveOrgCoords()
const std::string naturalBcElement
static boost::function< double(const double)> dd_f
static double f_log_e(const double v)
static constexpr double v_min
static int addCrackMeshsetId
static double inv_f_log_e(const double v)
MoFEMErrorCode createExchangeVectors(Sev sev)
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
boost::shared_ptr< Range > crackFaces
static boost::function< double(const double)> d_f
boost::shared_ptr< Range > frontVertices
static enum EnergyReleaseSelector energyReleaseSelector
MoFEMErrorCode addMaterial_HMHNeohookean(const int tape, const double c10, const double K)
static boost::function< double(const double)> inv_d_f
boost::shared_ptr< PressureBcVec > bcSpatialPressureVecPtr
static double d_f_linear(const double v)
const std::string hybridSpatialDisp
SmartPetscObj< Vec > solTSStep
static double f_log(const double v)
CommInterface::EntitiesPetscVector faceExchange
SmartPetscObj< DM > dmElastic
Elastic problem.
boost::shared_ptr< Range > frontEdges
static boost::function< double(const double)> inv_f
const std::string stretchTensor
BitRefLevel bitAdjEntMask
bit ref level for parent parent
static double f_linear(const double v)
const std::string contactElement
virtual moab::Interface & get_moab()=0
Deprecated interface functions.
base class for all interface classes
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.