v0.15.0
Loading...
Searching...
No Matches
EshelbianCore Struct Reference

#include "users_modules/eshelbian_plasticity/src/EshelbianCore.hpp"

Inheritance diagram for EshelbianCore:
[legend]
Collaboration diagram for EshelbianCore:
[legend]

Classes

struct  DynamicRelaxationTimeScale
 
struct  SetUpSchur
 

Public Member Functions

MoFEMErrorCode query_interface (boost::typeindex::type_index type_index, UnknownInterface **iface) const
 Getting interface of core database.
 
 EshelbianCore (MoFEM::Interface &m_field)
 
virtual ~EshelbianCore ()
 
MoFEMErrorCode getOptions ()
 
template<typename BC >
MoFEMErrorCode getBc (boost::shared_ptr< BC > &bc_vec_ptr, const std::string block_name, const int nb_attributes)
 
MoFEMErrorCode getSpatialDispBc ()
 
MoFEMErrorCode getSpatialRotationBc ()
 
MoFEMErrorCode getSpatialTractionBc ()
 
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 getSpatialTractionFreeBc (const EntityHandle meshset=0)
 
MoFEMErrorCode getExternalStrain ()
 
MoFEMErrorCode createExchangeVectors (Sev sev)
 
MoFEMErrorCode addFields (const EntityHandle meshset=0)
 
MoFEMErrorCode projectGeometry (const EntityHandle meshset=0)
 
MoFEMErrorCode addVolumeFiniteElement (const EntityHandle meshset=0)
 
MoFEMErrorCode addBoundaryFiniteElement (const EntityHandle meshset=0)
 
MoFEMErrorCode addDMs (const BitRefLevel bit=BitRefLevel().set(0), const EntityHandle meshset=0)
 
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 addMaterial_HMHNeohookean (const int tape, const double c10, const double K)
 
MoFEMErrorCode addMaterial_Hencky (double E, double nu)
 
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 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 setFaceElementOps (const bool add_elastic, const bool add_material, boost::shared_ptr< FaceElementForcesAndSourcesCore > &fe_rhs, boost::shared_ptr< FaceElementForcesAndSourcesCore > &fe_lhs)
 
MoFEMErrorCode setContactElementRhsOps (boost::shared_ptr< ContactTree > &fe_contact_tree)
 
MoFEMErrorCode setElasticElementOps (const int tag)
 
MoFEMErrorCode setElasticElementToTs (DM dm)
 
MoFEMErrorCode solveElastic (TS ts, Vec x)
 
MoFEMErrorCode solveDynamicRelaxation (TS ts, Vec x)
 
MoFEMErrorCode setBlockTagsOnSkin ()
 
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={})
 
MoFEMErrorCode postProcessSkeletonResults (const int tag, const std::string file, Vec f_residual=PETSC_NULLPTR, std::vector< Tag > tags_to_transfer={})
 
MoFEMErrorCode calculateCrackArea (boost::shared_ptr< double > area_ptr)
 
MoFEMErrorCode gettingNorms ()
 
MoFEMErrorCode calculateFaceMaterialForce (const int tag, TS ts)
 
MoFEMErrorCode calculateOrientation (const int tag, bool set_orientation)
 
MoFEMErrorCode setNewFrontCoordinates ()
 
MoFEMErrorCode addCrackSurfaces (const bool debug=false)
 
MoFEMErrorCode saveOrgCoords ()
 
MoFEMErrorCode createCrackSurfaceMeshset ()
 
- Public Member Functions inherited from MoFEM::UnknownInterface
virtual MoFEMErrorCode query_interface (boost::typeindex::type_index type_index, UnknownInterface **iface) const =0
 
template<class IFACE >
MoFEMErrorCode registerInterface (bool error_if_registration_failed=true)
 Register interface.
 
template<class IFACE >
MoFEMErrorCode getInterface (IFACE *&iface) const
 Get interface reference to pointer of interface.
 
template<class IFACE >
MoFEMErrorCode getInterface (IFACE **const iface) const
 Get interface pointer to pointer of interface.
 
template<class IFACE , typename boost::enable_if< boost::is_pointer< IFACE >, int >::type = 0>
IFACE getInterface () const
 Get interface pointer to pointer of interface.
 
template<class IFACE , typename boost::enable_if< boost::is_reference< IFACE >, int >::type = 0>
IFACE getInterface () const
 Get reference to interface.
 
template<class IFACE >
IFACE * getInterface () const
 Function returning pointer to interface.
 
virtual ~UnknownInterface ()=default
 

Static Public Member Functions

static double f_log_e_quadratic (const double v)
 
static double d_f_log_e_quadratic (const double v)
 
static double dd_f_log_e_quadratic (const double v)
 
static double f_log_e (const double v)
 
static double d_f_log_e (const double v)
 
static double dd_f_log_e (const double v)
 
static double inv_f_log_e (const double v)
 
static double inv_d_f_log_e (const double v)
 
static double inv_dd_f_log_e (const double v)
 
static double f_log (const double v)
 
static double d_f_log (const double v)
 
static double dd_f_log (const double v)
 
static double inv_f_log (const double v)
 
static double inv_d_f_log (const double v)
 
static double inv_dd_f_log (const double v)
 
static double f_linear (const double v)
 
static double d_f_linear (const double v)
 
static double dd_f_linear (const double v)
 
static double inv_f_linear (const double v)
 
static double inv_d_f_linear (const double v)
 
static double inv_dd_f_linear (const double v)
 
- Static Public Member Functions inherited from MoFEM::UnknownInterface
static MoFEMErrorCode getLibVersion (Version &version)
 Get library version.
 
static MoFEMErrorCode getFileVersion (moab::Interface &moab, Version &version)
 Get database major version.
 
static MoFEMErrorCode setFileVersion (moab::Interface &moab, Version version=Version(MoFEM_VERSION_MAJOR, MoFEM_VERSION_MINOR, MoFEM_VERSION_BUILD))
 Get database major version.
 
static MoFEMErrorCode getInterfaceVersion (Version &version)
 Get database major version.
 

Public Attributes

MoFEM::InterfacemField
 
boost::shared_ptr< DataAtIntegrationPtsdataAtPts
 
boost::shared_ptr< PhysicalEquations > physicalEquations
 
boost::shared_ptr< AnalyticalExprPython > AnalyticalExprPythonPtr
 
boost::shared_ptr< VolumeElementForcesAndSourcesCore > elasticFeRhs
 
boost::shared_ptr< VolumeElementForcesAndSourcesCore > elasticFeLhs
 
boost::shared_ptr< FaceElementForcesAndSourcesCoreelasticBcLhs
 
boost::shared_ptr< FaceElementForcesAndSourcesCoreelasticBcRhs
 
boost::shared_ptr< ContactTree > contactTreeRhs
 Make a contact tree.
 
SmartPetscObj< DM > dM
 Coupled problem all fields.
 
SmartPetscObj< DM > dmElastic
 Elastic problem.
 
SmartPetscObj< DM > dmMaterial
 Material problem.
 
SmartPetscObj< DM > dmPrjSpatial
 Projection spatial displacement.
 
const std::string piolaStress = "P"
 
const std::string spatialL2Disp = "wL2"
 
const std::string spatialH1Disp = "wH1"
 
const std::string materialH1Positions = "XH1"
 
const std::string hybridSpatialDisp = "hybridSpatialDisp"
 
const std::string contactDisp = "contactDisp"
 
const std::string stretchTensor = "u"
 
const std::string rotAxis = "omega"
 
const std::string bubbleField = "bubble"
 
const std::string elementVolumeName = "EP"
 
const std::string naturalBcElement = "NATURAL_BC"
 
const std::string skinElement = "SKIN"
 
const std::string skeletonElement = "SKELETON"
 
const std::string contactElement = "CONTACT"
 
int spaceOrder = 2
 
int spaceH1Order = -1
 
int materialOrder = 1
 
double alphaU = 0
 
double alphaW = 0
 
double alphaOmega = 0
 
double alphaRho = 0
 
int contactRefinementLevels = 1
 
int frontLayers = 3
 
boost::shared_ptr< BcDispVec > bcSpatialDispVecPtr
 
boost::shared_ptr< BcRotVec > bcSpatialRotationVecPtr
 
boost::shared_ptr< TractionBcVec > bcSpatialTractionVecPtr
 
boost::shared_ptr< TractionFreeBc > bcSpatialFreeTractionVecPtr
 
boost::shared_ptr< NormalDisplacementBcVec > bcSpatialNormalDisplacementVecPtr
 
boost::shared_ptr< AnalyticalDisplacementBcVec > bcSpatialAnalyticalDisplacementVecPtr
 
boost::shared_ptr< AnalyticalTractionBcVec > bcSpatialAnalyticalTractionVecPtr
 
boost::shared_ptr< PressureBcVec > bcSpatialPressureVecPtr
 
boost::shared_ptr< ExternalStrainVec > externalStrainVecPtr
 
std::map< std::string, boost::shared_ptr< ScalingMethod > > timeScaleMap
 
boost::shared_ptr< RangecontactFaces
 
boost::shared_ptr< RangecrackFaces
 
boost::shared_ptr< RangefrontEdges
 
boost::shared_ptr< RangefrontAdjEdges
 
boost::shared_ptr< RangefrontVertices
 
boost::shared_ptr< RangeskeletonFaces
 
boost::shared_ptr< RangematerialSkeletonFaces
 
boost::shared_ptr< RangemaxMovedFaces
 
boost::shared_ptr< ParentFiniteElementAdjacencyFunctionSkeleton< 2 > > parentAdjSkeletonFunctionDim2
 
BitRefLevel bitAdjParent = BitRefLevel().set()
 bit ref level for parent
 
BitRefLevel bitAdjParentMask
 bit ref level for parent parent
 
BitRefLevel bitAdjEnt = BitRefLevel().set()
 bit ref level for parent
 
BitRefLevel bitAdjEntMask
 bit ref level for parent parent
 
SmartPetscObj< Vec > solTSStep
 
CommInterface::EntitiesPetscVector volumeExchange
 
CommInterface::EntitiesPetscVector faceExchange
 
CommInterface::EntitiesPetscVector edgeExchange
 
CommInterface::EntitiesPetscVector vertexExchange
 
std::vector< TaglistTagsToTransfer
 list of tags to transfer to postprocessor
 
Mat S = PETSC_NULLPTR
 
AO aoS = PETSC_NULLPTR
 
SmartPetscObj< IS > crackHybridIs
 
std::vector< std::string > a00FieldList
 
std::vector< boost::shared_ptr< Range > > a00RangeList
 
int nbCrackFaces = 0
 

Static Public Attributes

static enum SymmetrySelector symmetrySelector = NOT_SYMMETRIC
 
static enum RotSelector rotSelector = LARGE_ROT
 
static enum RotSelector gradApproximator = LARGE_ROT
 
static enum StretchSelector stretchSelector = LOG
 
static PetscBool noStretch = PETSC_FALSE
 
static PetscBool setSingularity = PETSC_TRUE
 
static PetscBool dynamicRelaxation
 
static PetscBool crackingOn = PETSC_FALSE
 
static double crackingStartTime = 0
 
static int nbJIntegralLevels
 
static double dynamicTime
 
static int dynamicStep
 
static PetscBool l2UserBaseScale = PETSC_TRUE
 
static int addCrackMeshsetId = 1000
 
static double griffithEnergy = 1
 Griffith energy.
 
static enum EnergyReleaseSelector energyReleaseSelector
 
static std::string internalStressTagName
 
static int internalStressInterpOrder
 
static PetscBool internalStressVoigt
 
static double exponentBase
 
static boost::function< double(const double)> f
 
static boost::function< double(const double)> d_f
 
static boost::function< double(const double)> dd_f
 
static boost::function< double(const double)> inv_f
 
static boost::function< double(const double)> inv_d_f
 
static boost::function< double(const double)> inv_dd_f
 
static constexpr bool use_quadratic_exp = true
 
static constexpr double v_max = 12
 
static constexpr double v_min = -v_max
 

Friends

struct solve_elastic_set_up
 

Detailed Description

Examples
EshelbianPlasticity.cpp, and ep.cpp.

Definition at line 12 of file EshelbianCore.hpp.

Constructor & Destructor Documentation

◆ EshelbianCore()

EshelbianCore::EshelbianCore ( MoFEM::Interface & m_field)

◆ ~EshelbianCore()

virtual EshelbianCore::~EshelbianCore ( )
virtual

Member Function Documentation

◆ addBoundaryFiniteElement()

MoFEMErrorCode EshelbianCore::addBoundaryFiniteElement ( const EntityHandle meshset = 0)

◆ addCrackSurfaces()

MoFEMErrorCode EshelbianCore::addCrackSurfaces ( const bool debug = false)

◆ addDMs()

MoFEMErrorCode EshelbianCore::addDMs ( const BitRefLevel bit = BitRefLevel().set(0),
const EntityHandle meshset = 0 )

◆ addFields()

MoFEMErrorCode EshelbianCore::addFields ( const EntityHandle meshset = 0)

◆ addMaterial_Hencky()

MoFEMErrorCode EshelbianCore::addMaterial_Hencky ( double E,
double nu )
Examples
ep.cpp.

◆ addMaterial_HMHHStVenantKirchhoff()

MoFEMErrorCode EshelbianCore::addMaterial_HMHHStVenantKirchhoff ( const int tape,
const double lambda,
const double mu,
const double sigma_y )
Examples
ep.cpp.

◆ addMaterial_HMHMooneyRivlin()

MoFEMErrorCode EshelbianCore::addMaterial_HMHMooneyRivlin ( const int tape,
const double alpha,
const double beta,
const double lambda,
const double sigma_y )
Examples
ep.cpp.

◆ addMaterial_HMHNeohookean()

MoFEMErrorCode EshelbianCore::addMaterial_HMHNeohookean ( const int tape,
const double c10,
const double K )
Examples
ep.cpp.

◆ addVolumeFiniteElement()

MoFEMErrorCode EshelbianCore::addVolumeFiniteElement ( const EntityHandle meshset = 0)

◆ calculateCrackArea()

MoFEMErrorCode EshelbianCore::calculateCrackArea ( boost::shared_ptr< double > area_ptr)

◆ calculateFaceMaterialForce()

MoFEMErrorCode EshelbianCore::calculateFaceMaterialForce ( const int tag,
TS ts )

◆ calculateOrientation()

MoFEMErrorCode EshelbianCore::calculateOrientation ( const int tag,
bool set_orientation )

◆ createCrackSurfaceMeshset()

MoFEMErrorCode EshelbianCore::createCrackSurfaceMeshset ( )

◆ createExchangeVectors()

MoFEMErrorCode EshelbianCore::createExchangeVectors ( Sev sev)

◆ d_f_linear()

static double EshelbianCore::d_f_linear ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 159 of file EshelbianCore.hpp.

159{ return 1; }

◆ d_f_log()

static double EshelbianCore::d_f_log ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 140 of file EshelbianCore.hpp.

140 {
141 return pow(exponentBase, v) * log(EshelbianCore::exponentBase);
142 }
const double v
phase velocity of light in medium (cm/ns)
static double exponentBase

◆ d_f_log_e()

static double EshelbianCore::d_f_log_e ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 95 of file EshelbianCore.hpp.

95 {
96 if constexpr (use_quadratic_exp) {
97 return d_f_log_e_quadratic(v);
98 } else {
99 if (v > v_max)
100 return std::exp(v_max);
101 else
102 return std::exp(v);
103 }
104 }
static constexpr bool use_quadratic_exp
static constexpr double v_max
static double d_f_log_e_quadratic(const double v)

◆ d_f_log_e_quadratic()

static double EshelbianCore::d_f_log_e_quadratic ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 64 of file EshelbianCore.hpp.

64 {
65 if (v > v_max) {
66 double e = static_cast<double>(std::exp(v_max));
67 double dv = v - v_max;
68 return e * dv + e;
69 } else {
70 return static_cast<double>(std::exp(v));
71 }
72 }

◆ dd_f_linear()

static double EshelbianCore::dd_f_linear ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 160 of file EshelbianCore.hpp.

160{ return 0; }

◆ dd_f_log()

static double EshelbianCore::dd_f_log ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 143 of file EshelbianCore.hpp.

◆ dd_f_log_e()

static double EshelbianCore::dd_f_log_e ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 105 of file EshelbianCore.hpp.

105 {
106 if constexpr (use_quadratic_exp) {
107 return dd_f_log_e_quadratic(v);
108 } else {
109 if (v > v_max)
110 return 0.;
111 else
112 return std::exp(v);
113 }
114 }
static double dd_f_log_e_quadratic(const double v)

◆ dd_f_log_e_quadratic()

static double EshelbianCore::dd_f_log_e_quadratic ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 74 of file EshelbianCore.hpp.

74 {
75 if (v > v_max) {
76 return static_cast<double>(std::exp(v_max));
77 } else {
78 return static_cast<double>(std::exp(v));
79 }
80 }

◆ f_linear()

static double EshelbianCore::f_linear ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 158 of file EshelbianCore.hpp.

158{ return v + 1; }

◆ f_log()

static double EshelbianCore::f_log ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 137 of file EshelbianCore.hpp.

137 {
138 return pow(EshelbianCore::exponentBase, v);
139 }

◆ f_log_e()

static double EshelbianCore::f_log_e ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 82 of file EshelbianCore.hpp.

82 {
83 if constexpr(use_quadratic_exp) {
84 return f_log_e_quadratic(v);
85 } else {
86 if (v > v_max)
87 // y = exp(v_max) * v + exp(v_max) * (1 - v_max);
88 // y/exp(v_max) = v + (1 - v_max);
89 // y/exp(v_max) - (1 - v_max) = v;
90 return std::exp(v_max) * v + std::exp(v_max) * (1 - v_max);
91 else
92 return std::exp(v);
93 }
94 }
static double f_log_e_quadratic(const double v)

◆ f_log_e_quadratic()

static double EshelbianCore::f_log_e_quadratic ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 54 of file EshelbianCore.hpp.

54 {
55 if (v > v_max) {
56 double e = static_cast<double>(std::exp(v_max));
57 double dv = v - v_max;
58 return 0.5 * e * dv * dv + e * dv + e;
59 } else {
60 return static_cast<double>(std::exp(v));
61 }
62 }

◆ getBc()

template<typename BC >
MoFEMErrorCode EshelbianCore::getBc ( boost::shared_ptr< BC > & bc_vec_ptr,
const std::string block_name,
const int nb_attributes )
inline
Examples
EshelbianPlasticity.cpp.

Definition at line 243 of file EshelbianCore.hpp.

244 {
246 for (auto it :
247 mField.getInterface<MeshsetsManager>()->getCubitMeshsetPtr(std::regex(
248
249 (boost::format("%s(.*)") % block_name).str()
250
251 ))
252
253 ) {
254 std::vector<double> block_attributes;
255 CHKERR it->getAttributes(block_attributes);
256 if (block_attributes.size() < nb_attributes) {
257 SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
258 "In block %s expected %d attributes, but given %ld",
259 it->getName().c_str(), nb_attributes, block_attributes.size());
260 }
261 Range faces;
262 CHKERR it->getMeshsetIdEntitiesByDimension(mField.get_moab(), 2, faces,
263 true);
264 bc_vec_ptr->emplace_back(it->getName(), block_attributes, faces);
265 }
267 }
#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.
MoFEM::Interface & mField
virtual moab::Interface & get_moab()=0
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.

◆ getExternalStrain()

MoFEMErrorCode EshelbianCore::getExternalStrain ( )

◆ getOptions()

MoFEMErrorCode EshelbianCore::getOptions ( )

◆ getSpatialDispBc()

MoFEMErrorCode EshelbianCore::getSpatialDispBc ( )

◆ getSpatialRotationBc()

MoFEMErrorCode EshelbianCore::getSpatialRotationBc ( )
inline
Examples
ep.cpp.

Definition at line 271 of file EshelbianCore.hpp.

271 {
273 bcSpatialRotationVecPtr = boost::make_shared<BcRotVec>();
274 CHKERR getBc(bcSpatialRotationVecPtr, "SPATIAL_ROTATION_BC", 4);
275 CHKERR getBc(bcSpatialRotationVecPtr, "SPATIAL_ROTATION_AXIS_BC", 7);
276
277 auto ts_rotation =
278 boost::make_shared<DynamicRelaxationTimeScale>("rotation_history.txt");
279 for (auto &bc : *bcSpatialRotationVecPtr) {
280 timeScaleMap[bc.blockName] =
281 GetBlockScalingMethod<DynamicRelaxationTimeScale>::get(
282 ts_rotation, "rotation_history", ".txt", bc.blockName);
283 }
284
286 }
std::map< std::string, boost::shared_ptr< ScalingMethod > > timeScaleMap
MoFEMErrorCode getBc(boost::shared_ptr< BC > &bc_vec_ptr, const std::string block_name, const int nb_attributes)
boost::shared_ptr< BcRotVec > bcSpatialRotationVecPtr

◆ getSpatialTractionBc()

MoFEMErrorCode EshelbianCore::getSpatialTractionBc ( )

◆ getSpatialTractionFreeBc()

MoFEMErrorCode EshelbianCore::getSpatialTractionFreeBc ( const EntityHandle meshset = 0)
inline
Examples
ep.cpp.

Definition at line 305 of file EshelbianCore.hpp.

305 {
307 boost::shared_ptr<TractionFreeBc>(new TractionFreeBc());
308 return getTractionFreeBc(meshset, bcSpatialFreeTractionVecPtr, "CONTACT");
309 }
std::vector< Range > TractionFreeBc
boost::shared_ptr< TractionFreeBc > bcSpatialFreeTractionVecPtr
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.

◆ gettingNorms()

MoFEMErrorCode EshelbianCore::gettingNorms ( )

◆ getTractionFreeBc()

MoFEMErrorCode EshelbianCore::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.

Parameters
meshset
bc_ptr
disp_block_set_name
rot_block_set_name
contact_set_name
Returns
MoFEMErrorCode
Examples
EshelbianPlasticity.cpp.

◆ inv_d_f_linear()

static double EshelbianCore::inv_d_f_linear ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 163 of file EshelbianCore.hpp.

163{ return 0; }

◆ inv_d_f_log()

static double EshelbianCore::inv_d_f_log ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 151 of file EshelbianCore.hpp.

151 {
152 return (1. / v) / log(EshelbianCore::exponentBase);
153 }

◆ inv_d_f_log_e()

static double EshelbianCore::inv_d_f_log_e ( const double v)
inlinestatic

Definition at line 124 of file EshelbianCore.hpp.

124 {
125 if (v > std::exp(v_min))
126 return 1. / v;
127 else
128 return 1. / exp(v_min);
129 }
static constexpr double v_min

◆ inv_dd_f_linear()

static double EshelbianCore::inv_dd_f_linear ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 164 of file EshelbianCore.hpp.

164{ return 0; }

◆ inv_dd_f_log()

static double EshelbianCore::inv_dd_f_log ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 154 of file EshelbianCore.hpp.

154 {
155 return -(1. / (v * v)) / log(EshelbianCore::exponentBase);
156 }

◆ inv_dd_f_log_e()

static double EshelbianCore::inv_dd_f_log_e ( const double v)
inlinestatic

Definition at line 130 of file EshelbianCore.hpp.

130 {
131 if (v > std::exp(v_min))
132 return -1. / (v * v);
133 else
134 return 0.;
135 }

◆ inv_f_linear()

static double EshelbianCore::inv_f_linear ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 162 of file EshelbianCore.hpp.

162{ return v - 1; }

◆ inv_f_log()

static double EshelbianCore::inv_f_log ( const double v)
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 148 of file EshelbianCore.hpp.

148 {
149 return log(v) / log(EshelbianCore::exponentBase);
150 }

◆ inv_f_log_e()

static double EshelbianCore::inv_f_log_e ( const double v)
inlinestatic

Definition at line 115 of file EshelbianCore.hpp.

115 {
116 if (v > std::exp(v_min))
117 return std::log(v);
118 else
119 // y = exp(v_min) * v + exp(v_min) * (1 - v_min);
120 // y/exp(v_min) = v + (1 - v_min);
121 // y/exp(v_min) - (1 - v_min) = v;
122 return v / exp(v_min) - (1 - v_min);
123 }

◆ postProcessResults()

MoFEMErrorCode EshelbianCore::postProcessResults ( const int tag,
const std::string file,
Vec f_residual = PETSC_NULLPTR,
Vec var_vec = PETSC_NULLPTR,
std::vector< Tag > tags_to_transfer = {} )

◆ postProcessSkeletonResults()

MoFEMErrorCode EshelbianCore::postProcessSkeletonResults ( const int tag,
const std::string file,
Vec f_residual = PETSC_NULLPTR,
std::vector< Tag > tags_to_transfer = {} )

◆ projectGeometry()

MoFEMErrorCode EshelbianCore::projectGeometry ( const EntityHandle meshset = 0)

◆ query_interface()

MoFEMErrorCode EshelbianCore::query_interface ( boost::typeindex::type_index type_index,
UnknownInterface ** iface ) const

Getting interface of core database.

Parameters
uuidunique ID of interface
ifacereturned pointer to interface
Returns
error code

◆ saveOrgCoords()

MoFEMErrorCode EshelbianCore::saveOrgCoords ( )

◆ setBaseVolumeElementOps()

MoFEMErrorCode EshelbianCore::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 )

◆ setBlockTagsOnSkin()

MoFEMErrorCode EshelbianCore::setBlockTagsOnSkin ( )

◆ setContactElementRhsOps()

MoFEMErrorCode EshelbianCore::setContactElementRhsOps ( boost::shared_ptr< ContactTree > & fe_contact_tree)

◆ setElasticElementOps()

MoFEMErrorCode EshelbianCore::setElasticElementOps ( const int tag)

◆ setElasticElementToTs()

MoFEMErrorCode EshelbianCore::setElasticElementToTs ( DM dm)

◆ setFaceElementOps()

MoFEMErrorCode EshelbianCore::setFaceElementOps ( const bool add_elastic,
const bool add_material,
boost::shared_ptr< FaceElementForcesAndSourcesCore > & fe_rhs,
boost::shared_ptr< FaceElementForcesAndSourcesCore > & fe_lhs )

◆ setNewFrontCoordinates()

MoFEMErrorCode EshelbianCore::setNewFrontCoordinates ( )

◆ setVolumeElementOps()

MoFEMErrorCode EshelbianCore::setVolumeElementOps ( const int tag,
const bool add_elastic,
const bool add_material,
boost::shared_ptr< VolumeElementForcesAndSourcesCore > & fe_rhs,
boost::shared_ptr< VolumeElementForcesAndSourcesCore > & fe_lhs )

◆ solveDynamicRelaxation()

MoFEMErrorCode EshelbianCore::solveDynamicRelaxation ( TS ts,
Vec x )

◆ solveElastic()

MoFEMErrorCode EshelbianCore::solveElastic ( TS ts,
Vec x )

Friends And Related Symbol Documentation

◆ solve_elastic_set_up

friend struct solve_elastic_set_up
friend

Definition at line 362 of file EshelbianCore.hpp.

Member Data Documentation

◆ a00FieldList

std::vector<std::string> EshelbianCore::a00FieldList

Definition at line 446 of file EshelbianCore.hpp.

◆ a00RangeList

std::vector<boost::shared_ptr<Range> > EshelbianCore::a00RangeList

Definition at line 448 of file EshelbianCore.hpp.

◆ addCrackMeshsetId

int EshelbianCore::addCrackMeshsetId = 1000
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 31 of file EshelbianCore.hpp.

◆ alphaOmega

double EshelbianCore::alphaOmega = 0
Examples
EshelbianPlasticity.cpp.

Definition at line 221 of file EshelbianCore.hpp.

◆ alphaRho

double EshelbianCore::alphaRho = 0
Examples
EshelbianPlasticity.cpp.

Definition at line 222 of file EshelbianCore.hpp.

◆ alphaU

double EshelbianCore::alphaU = 0
Examples
EshelbianPlasticity.cpp.

Definition at line 219 of file EshelbianCore.hpp.

◆ alphaW

double EshelbianCore::alphaW = 0
Examples
EshelbianPlasticity.cpp.

Definition at line 220 of file EshelbianCore.hpp.

◆ AnalyticalExprPythonPtr

boost::shared_ptr<AnalyticalExprPython> EshelbianCore::AnalyticalExprPythonPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 179 of file EshelbianCore.hpp.

◆ aoS

AO EshelbianCore::aoS = PETSC_NULLPTR

Definition at line 444 of file EshelbianCore.hpp.

◆ bcSpatialAnalyticalDisplacementVecPtr

boost::shared_ptr<AnalyticalDisplacementBcVec> EshelbianCore::bcSpatialAnalyticalDisplacementVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 235 of file EshelbianCore.hpp.

◆ bcSpatialAnalyticalTractionVecPtr

boost::shared_ptr<AnalyticalTractionBcVec> EshelbianCore::bcSpatialAnalyticalTractionVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 236 of file EshelbianCore.hpp.

◆ bcSpatialDispVecPtr

boost::shared_ptr<BcDispVec> EshelbianCore::bcSpatialDispVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 229 of file EshelbianCore.hpp.

◆ bcSpatialFreeTractionVecPtr

boost::shared_ptr<TractionFreeBc> EshelbianCore::bcSpatialFreeTractionVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 232 of file EshelbianCore.hpp.

◆ bcSpatialNormalDisplacementVecPtr

boost::shared_ptr<NormalDisplacementBcVec> EshelbianCore::bcSpatialNormalDisplacementVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 233 of file EshelbianCore.hpp.

◆ bcSpatialPressureVecPtr

boost::shared_ptr<PressureBcVec> EshelbianCore::bcSpatialPressureVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 237 of file EshelbianCore.hpp.

◆ bcSpatialRotationVecPtr

boost::shared_ptr<BcRotVec> EshelbianCore::bcSpatialRotationVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 230 of file EshelbianCore.hpp.

◆ bcSpatialTractionVecPtr

boost::shared_ptr<TractionBcVec> EshelbianCore::bcSpatialTractionVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 231 of file EshelbianCore.hpp.

◆ bitAdjEnt

BitRefLevel EshelbianCore::bitAdjEnt = BitRefLevel().set()

bit ref level for parent

Examples
EshelbianPlasticity.cpp.

Definition at line 429 of file EshelbianCore.hpp.

◆ bitAdjEntMask

BitRefLevel EshelbianCore::bitAdjEntMask
Initial value:
=
BitRefLevel().set()

bit ref level for parent parent

Examples
EshelbianPlasticity.cpp.

Definition at line 430 of file EshelbianCore.hpp.

◆ bitAdjParent

BitRefLevel EshelbianCore::bitAdjParent = BitRefLevel().set()

bit ref level for parent

Examples
EshelbianPlasticity.cpp.

Definition at line 426 of file EshelbianCore.hpp.

◆ bitAdjParentMask

BitRefLevel EshelbianCore::bitAdjParentMask
Initial value:
=
BitRefLevel().set()

bit ref level for parent parent

Examples
EshelbianPlasticity.cpp.

Definition at line 427 of file EshelbianCore.hpp.

◆ bubbleField

const std::string EshelbianCore::bubbleField = "bubble"
Examples
EshelbianPlasticity.cpp.

Definition at line 203 of file EshelbianCore.hpp.

◆ contactDisp

const std::string EshelbianCore::contactDisp = "contactDisp"
Examples
EshelbianPlasticity.cpp.

Definition at line 200 of file EshelbianCore.hpp.

◆ contactElement

const std::string EshelbianCore::contactElement = "CONTACT"
Examples
EshelbianPlasticity.cpp.

Definition at line 209 of file EshelbianCore.hpp.

◆ contactFaces

boost::shared_ptr<Range> EshelbianCore::contactFaces
Examples
EshelbianPlasticity.cpp.

Definition at line 414 of file EshelbianCore.hpp.

◆ contactRefinementLevels

int EshelbianCore::contactRefinementLevels = 1
Examples
EshelbianPlasticity.cpp.

Definition at line 224 of file EshelbianCore.hpp.

◆ contactTreeRhs

boost::shared_ptr<ContactTree> EshelbianCore::contactTreeRhs

Make a contact tree.

Examples
EshelbianPlasticity.cpp.

Definition at line 185 of file EshelbianCore.hpp.

◆ crackFaces

boost::shared_ptr<Range> EshelbianCore::crackFaces
Examples
EshelbianPlasticity.cpp.

Definition at line 415 of file EshelbianCore.hpp.

◆ crackHybridIs

SmartPetscObj<IS> EshelbianCore::crackHybridIs

Definition at line 445 of file EshelbianCore.hpp.

◆ crackingOn

PetscBool EshelbianCore::crackingOn = PETSC_FALSE
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 22 of file EshelbianCore.hpp.

◆ crackingStartTime

double EshelbianCore::crackingStartTime = 0
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 23 of file EshelbianCore.hpp.

◆ d_f

boost::function<double(const double)> EshelbianCore::d_f
static
Examples
EshelbianPlasticity.cpp.

Definition at line 44 of file EshelbianCore.hpp.

◆ dataAtPts

boost::shared_ptr<DataAtIntegrationPts> EshelbianCore::dataAtPts
Examples
EshelbianPlasticity.cpp.

Definition at line 177 of file EshelbianCore.hpp.

◆ dd_f

boost::function<double(const double)> EshelbianCore::dd_f
static
Examples
EshelbianPlasticity.cpp.

Definition at line 45 of file EshelbianCore.hpp.

◆ dM

SmartPetscObj<DM> EshelbianCore::dM

Coupled problem all fields.

Examples
EshelbianPlasticity.cpp.

Definition at line 187 of file EshelbianCore.hpp.

◆ dmElastic

SmartPetscObj<DM> EshelbianCore::dmElastic

Elastic problem.

Examples
EshelbianPlasticity.cpp, and ep.cpp.

Definition at line 188 of file EshelbianCore.hpp.

◆ dmMaterial

SmartPetscObj<DM> EshelbianCore::dmMaterial

Material problem.

Definition at line 189 of file EshelbianCore.hpp.

◆ dmPrjSpatial

SmartPetscObj<DM> EshelbianCore::dmPrjSpatial

Projection spatial displacement.

Examples
EshelbianPlasticity.cpp.

Definition at line 190 of file EshelbianCore.hpp.

◆ dynamicRelaxation

PetscBool EshelbianCore::dynamicRelaxation
inlinestatic
Initial value:
=
PETSC_FALSE
Examples
EshelbianPlasticity.cpp, and ep.cpp.

Definition at line 20 of file EshelbianCore.hpp.

◆ dynamicStep

int EshelbianCore::dynamicStep
inlinestatic
Initial value:
=
0
Examples
EshelbianPlasticity.cpp.

Definition at line 28 of file EshelbianCore.hpp.

◆ dynamicTime

double EshelbianCore::dynamicTime
inlinestatic
Initial value:
=
0
Examples
EshelbianPlasticity.cpp.

Definition at line 26 of file EshelbianCore.hpp.

◆ edgeExchange

CommInterface::EntitiesPetscVector EshelbianCore::edgeExchange
Examples
EshelbianPlasticity.cpp.

Definition at line 437 of file EshelbianCore.hpp.

◆ elasticBcLhs

boost::shared_ptr<FaceElementForcesAndSourcesCore> EshelbianCore::elasticBcLhs
Examples
EshelbianPlasticity.cpp.

Definition at line 183 of file EshelbianCore.hpp.

◆ elasticBcRhs

boost::shared_ptr<FaceElementForcesAndSourcesCore> EshelbianCore::elasticBcRhs
Examples
EshelbianPlasticity.cpp.

Definition at line 184 of file EshelbianCore.hpp.

◆ elasticFeLhs

boost::shared_ptr<VolumeElementForcesAndSourcesCore> EshelbianCore::elasticFeLhs
Examples
EshelbianPlasticity.cpp.

Definition at line 182 of file EshelbianCore.hpp.

◆ elasticFeRhs

boost::shared_ptr<VolumeElementForcesAndSourcesCore> EshelbianCore::elasticFeRhs
Examples
EshelbianPlasticity.cpp.

Definition at line 181 of file EshelbianCore.hpp.

◆ elementVolumeName

const std::string EshelbianCore::elementVolumeName = "EP"
Examples
EshelbianPlasticity.cpp.

Definition at line 205 of file EshelbianCore.hpp.

◆ energyReleaseSelector

enum EnergyReleaseSelector EshelbianCore::energyReleaseSelector
inlinestatic
Initial value:
=
GRIFFITH_SKELETON
Examples
EshelbianPlasticity.cpp.

Definition at line 33 of file EshelbianCore.hpp.

◆ exponentBase

double EshelbianCore::exponentBase
static
Examples
EshelbianPlasticity.cpp.

Definition at line 42 of file EshelbianCore.hpp.

◆ externalStrainVecPtr

boost::shared_ptr<ExternalStrainVec> EshelbianCore::externalStrainVecPtr
Examples
EshelbianPlasticity.cpp.

Definition at line 238 of file EshelbianCore.hpp.

◆ f

boost::function<double(const double)> EshelbianCore::f
static
Examples
EshelbianPlasticity.cpp.

Definition at line 43 of file EshelbianCore.hpp.

◆ faceExchange

CommInterface::EntitiesPetscVector EshelbianCore::faceExchange
Examples
EshelbianPlasticity.cpp.

Definition at line 436 of file EshelbianCore.hpp.

◆ frontAdjEdges

boost::shared_ptr<Range> EshelbianCore::frontAdjEdges
Examples
EshelbianPlasticity.cpp.

Definition at line 417 of file EshelbianCore.hpp.

◆ frontEdges

boost::shared_ptr<Range> EshelbianCore::frontEdges
Examples
EshelbianPlasticity.cpp.

Definition at line 416 of file EshelbianCore.hpp.

◆ frontLayers

int EshelbianCore::frontLayers = 3

Definition at line 225 of file EshelbianCore.hpp.

◆ frontVertices

boost::shared_ptr<Range> EshelbianCore::frontVertices
Examples
EshelbianPlasticity.cpp.

Definition at line 418 of file EshelbianCore.hpp.

◆ gradApproximator

enum RotSelector EshelbianCore::gradApproximator = LARGE_ROT
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 16 of file EshelbianCore.hpp.

◆ griffithEnergy

double EshelbianCore::griffithEnergy = 1
inlinestatic

Griffith energy.

Examples
EshelbianPlasticity.cpp.

Definition at line 32 of file EshelbianCore.hpp.

◆ hybridSpatialDisp

const std::string EshelbianCore::hybridSpatialDisp = "hybridSpatialDisp"
Examples
EshelbianPlasticity.cpp.

Definition at line 198 of file EshelbianCore.hpp.

◆ internalStressInterpOrder

int EshelbianCore::internalStressInterpOrder
inlinestatic
Initial value:
=
1
Examples
EshelbianPlasticity.cpp.

Definition at line 37 of file EshelbianCore.hpp.

◆ internalStressTagName

std::string EshelbianCore::internalStressTagName
inlinestatic
Initial value:
=
""
Examples
EshelbianPlasticity.cpp.

Definition at line 35 of file EshelbianCore.hpp.

◆ internalStressVoigt

PetscBool EshelbianCore::internalStressVoigt
inlinestatic
Initial value:
=
PETSC_FALSE
Examples
EshelbianPlasticity.cpp.

Definition at line 39 of file EshelbianCore.hpp.

◆ inv_d_f

boost::function<double(const double)> EshelbianCore::inv_d_f
static
Examples
EshelbianPlasticity.cpp.

Definition at line 47 of file EshelbianCore.hpp.

◆ inv_dd_f

boost::function<double(const double)> EshelbianCore::inv_dd_f
static
Examples
EshelbianPlasticity.cpp.

Definition at line 48 of file EshelbianCore.hpp.

◆ inv_f

boost::function<double(const double)> EshelbianCore::inv_f
static
Examples
EshelbianPlasticity.cpp.

Definition at line 46 of file EshelbianCore.hpp.

◆ l2UserBaseScale

PetscBool EshelbianCore::l2UserBaseScale = PETSC_TRUE
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 30 of file EshelbianCore.hpp.

◆ listTagsToTransfer

std::vector<Tag> EshelbianCore::listTagsToTransfer

list of tags to transfer to postprocessor

Examples
EshelbianPlasticity.cpp.

Definition at line 441 of file EshelbianCore.hpp.

◆ materialH1Positions

const std::string EshelbianCore::materialH1Positions = "XH1"
Examples
EshelbianPlasticity.cpp.

Definition at line 197 of file EshelbianCore.hpp.

◆ materialOrder

int EshelbianCore::materialOrder = 1
Examples
EshelbianPlasticity.cpp.

Definition at line 218 of file EshelbianCore.hpp.

◆ materialSkeletonFaces

boost::shared_ptr<Range> EshelbianCore::materialSkeletonFaces

Definition at line 420 of file EshelbianCore.hpp.

◆ maxMovedFaces

boost::shared_ptr<Range> EshelbianCore::maxMovedFaces
Examples
EshelbianPlasticity.cpp.

Definition at line 421 of file EshelbianCore.hpp.

◆ mField

MoFEM::Interface& EshelbianCore::mField
Examples
EshelbianPlasticity.cpp.

Definition at line 175 of file EshelbianCore.hpp.

◆ naturalBcElement

const std::string EshelbianCore::naturalBcElement = "NATURAL_BC"
Examples
EshelbianPlasticity.cpp.

Definition at line 206 of file EshelbianCore.hpp.

◆ nbCrackFaces

int EshelbianCore::nbCrackFaces = 0
Examples
EshelbianPlasticity.cpp.

Definition at line 450 of file EshelbianCore.hpp.

◆ nbJIntegralLevels

int EshelbianCore::nbJIntegralLevels
inlinestatic
Initial value:
=
0
Examples
EshelbianPlasticity.cpp.

Definition at line 24 of file EshelbianCore.hpp.

◆ noStretch

PetscBool EshelbianCore::noStretch = PETSC_FALSE
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 18 of file EshelbianCore.hpp.

◆ parentAdjSkeletonFunctionDim2

boost::shared_ptr<ParentFiniteElementAdjacencyFunctionSkeleton<2> > EshelbianCore::parentAdjSkeletonFunctionDim2
Examples
EshelbianPlasticity.cpp.

Definition at line 424 of file EshelbianCore.hpp.

◆ physicalEquations

boost::shared_ptr<PhysicalEquations> EshelbianCore::physicalEquations
Examples
EshelbianPlasticity.cpp.

Definition at line 178 of file EshelbianCore.hpp.

◆ piolaStress

const std::string EshelbianCore::piolaStress = "P"
Examples
EshelbianPlasticity.cpp.

Definition at line 192 of file EshelbianCore.hpp.

◆ rotAxis

const std::string EshelbianCore::rotAxis = "omega"
Examples
EshelbianPlasticity.cpp.

Definition at line 202 of file EshelbianCore.hpp.

◆ rotSelector

enum RotSelector EshelbianCore::rotSelector = LARGE_ROT
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 15 of file EshelbianCore.hpp.

◆ S

Mat EshelbianCore::S = PETSC_NULLPTR

Definition at line 443 of file EshelbianCore.hpp.

◆ setSingularity

PetscBool EshelbianCore::setSingularity = PETSC_TRUE
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 19 of file EshelbianCore.hpp.

◆ skeletonElement

const std::string EshelbianCore::skeletonElement = "SKELETON"
Examples
EshelbianPlasticity.cpp.

Definition at line 208 of file EshelbianCore.hpp.

◆ skeletonFaces

boost::shared_ptr<Range> EshelbianCore::skeletonFaces
Examples
EshelbianPlasticity.cpp.

Definition at line 419 of file EshelbianCore.hpp.

◆ skinElement

const std::string EshelbianCore::skinElement = "SKIN"
Examples
EshelbianPlasticity.cpp.

Definition at line 207 of file EshelbianCore.hpp.

◆ solTSStep

SmartPetscObj<Vec> EshelbianCore::solTSStep
Examples
EshelbianPlasticity.cpp.

Definition at line 433 of file EshelbianCore.hpp.

◆ spaceH1Order

int EshelbianCore::spaceH1Order = -1
Examples
EshelbianPlasticity.cpp.

Definition at line 217 of file EshelbianCore.hpp.

◆ spaceOrder

int EshelbianCore::spaceOrder = 2
Examples
EshelbianPlasticity.cpp.

Definition at line 216 of file EshelbianCore.hpp.

◆ spatialH1Disp

const std::string EshelbianCore::spatialH1Disp = "wH1"
Examples
EshelbianPlasticity.cpp.

Definition at line 196 of file EshelbianCore.hpp.

◆ spatialL2Disp

const std::string EshelbianCore::spatialL2Disp = "wL2"
Examples
EshelbianPlasticity.cpp.

Definition at line 194 of file EshelbianCore.hpp.

◆ stretchSelector

enum StretchSelector EshelbianCore::stretchSelector = LOG
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 17 of file EshelbianCore.hpp.

◆ stretchTensor

const std::string EshelbianCore::stretchTensor = "u"
Examples
EshelbianPlasticity.cpp.

Definition at line 201 of file EshelbianCore.hpp.

◆ symmetrySelector

enum SymmetrySelector EshelbianCore::symmetrySelector = NOT_SYMMETRIC
inlinestatic
Examples
EshelbianPlasticity.cpp.

Definition at line 14 of file EshelbianCore.hpp.

◆ timeScaleMap

std::map<std::string, boost::shared_ptr<ScalingMethod> > EshelbianCore::timeScaleMap
Examples
EshelbianPlasticity.cpp.

Definition at line 240 of file EshelbianCore.hpp.

◆ use_quadratic_exp

bool EshelbianCore::use_quadratic_exp = true
inlinestaticconstexpr

Definition at line 50 of file EshelbianCore.hpp.

◆ v_max

double EshelbianCore::v_max = 12
inlinestaticconstexpr

Definition at line 51 of file EshelbianCore.hpp.

◆ v_min

double EshelbianCore::v_min = -v_max
inlinestaticconstexpr

Definition at line 52 of file EshelbianCore.hpp.

◆ vertexExchange

CommInterface::EntitiesPetscVector EshelbianCore::vertexExchange
Examples
EshelbianPlasticity.cpp.

Definition at line 438 of file EshelbianCore.hpp.

◆ volumeExchange

CommInterface::EntitiesPetscVector EshelbianCore::volumeExchange
Examples
EshelbianPlasticity.cpp.

Definition at line 435 of file EshelbianCore.hpp.


The documentation for this struct was generated from the following file: