![]() |
v0.15.0 |
#include "users_modules/eshelbian_plasticity/src/EshelbianPlasticity.hpp"
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 () |
[Getting norms] | |
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 () |
[Getting norms] | |
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 () |
![]() | |
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 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::Interface & | mField |
boost::shared_ptr< DataAtIntegrationPts > | dataAtPts |
boost::shared_ptr< PhysicalEquations > | physicalEquations |
boost::shared_ptr< AnalyticalExprPython > | AnalyticalExprPythonPtr |
boost::shared_ptr< VolumeElementForcesAndSourcesCore > | elasticFeRhs |
boost::shared_ptr< VolumeElementForcesAndSourcesCore > | elasticFeLhs |
boost::shared_ptr< FaceElementForcesAndSourcesCore > | elasticBcLhs |
boost::shared_ptr< FaceElementForcesAndSourcesCore > | elasticBcRhs |
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< Range > | contactFaces |
boost::shared_ptr< Range > | crackFaces |
boost::shared_ptr< Range > | frontEdges |
boost::shared_ptr< Range > | frontAdjEdges |
boost::shared_ptr< Range > | frontVertices |
boost::shared_ptr< Range > | skeletonFaces |
boost::shared_ptr< Range > | materialSkeletonFaces |
boost::shared_ptr< Range > | maxMovedFaces |
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< Tag > | listTagsToTransfer |
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 = exp(1) |
static boost::function< double(const double)> | f = EshelbianCore::f_log_e |
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 |
Definition at line 13 of file EshelbianPlasticity.hpp.
EshelbianCore::EshelbianCore | ( | MoFEM::Interface & | m_field | ) |
Definition at line 913 of file EshelbianPlasticity.cpp.
|
virtualdefault |
MoFEMErrorCode EshelbianCore::addBoundaryFiniteElement | ( | const EntityHandle | meshset = 0 | ) |
Definition at line 1593 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::addCrackSurfaces | ( | const bool | debug = false | ) |
Definition at line 5941 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::addDMs | ( | const BitRefLevel | bit = BitRefLevel().set(0), |
const EntityHandle | meshset = 0 ) |
Definition at line 1793 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::addFields | ( | const EntityHandle | meshset = 0 | ) |
Definition at line 1154 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::addMaterial_Hencky | ( | double | E, |
double | nu ) |
Definition at line 540 of file EshelbianADOL-C.cpp.
MoFEMErrorCode EshelbianCore::addMaterial_HMHHStVenantKirchhoff | ( | const int | tape, |
const double | lambda, | ||
const double | mu, | ||
const double | sigma_y ) |
Definition at line 513 of file EshelbianADOL-C.cpp.
MoFEMErrorCode EshelbianCore::addMaterial_HMHMooneyRivlin | ( | const int | tape, |
const double | alpha, | ||
const double | beta, | ||
const double | lambda, | ||
const double | sigma_y ) |
Definition at line 522 of file EshelbianADOL-C.cpp.
MoFEMErrorCode EshelbianCore::addMaterial_HMHNeohookean | ( | const int | tape, |
const double | c10, | ||
const double | K ) |
Definition at line 531 of file EshelbianADOL-C.cpp.
MoFEMErrorCode EshelbianCore::addVolumeFiniteElement | ( | const EntityHandle | meshset = 0 | ) |
Definition at line 1530 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::calculateCrackArea | ( | boost::shared_ptr< double > | area_ptr | ) |
Definition at line 7035 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::calculateFaceMaterialForce | ( | const int | tag, |
TS | ts ) |
Create element to integration faces energies
Definition at line 4299 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianPlasticity::EshelbianCore::calculateOrientation | ( | const int | tag, |
bool | set_orientation ) |
Iterate over front edges, get adjacent faces, find maximal face energy. Maximal face energy is stored in the edge. Maximal face energy is magnitude of edge Griffith force.
For each front edge, find maximal face energy and orientation. This is by finding angle between edge material force and maximal face normal
Definition at line 4872 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::createCrackSurfaceMeshset | ( | ) |
Definition at line 6698 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::createExchangeVectors | ( | Sev | sev | ) |
Definition at line 7003 of file EshelbianPlasticity.cpp.
Definition at line 160 of file EshelbianPlasticity.hpp.
Definition at line 141 of file EshelbianPlasticity.hpp.
Definition at line 96 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 65 of file EshelbianPlasticity.hpp.
Definition at line 161 of file EshelbianPlasticity.hpp.
Definition at line 144 of file EshelbianPlasticity.hpp.
Definition at line 106 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 75 of file EshelbianPlasticity.hpp.
Definition at line 159 of file EshelbianPlasticity.hpp.
Definition at line 138 of file EshelbianPlasticity.hpp.
Definition at line 83 of file EshelbianPlasticity.hpp.
Definition at line 55 of file EshelbianPlasticity.hpp.
|
inline |
Definition at line 244 of file EshelbianPlasticity.hpp.
MoFEMErrorCode EshelbianCore::getExternalStrain | ( | ) |
Definition at line 6956 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::getOptions | ( | ) |
Definition at line 919 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianPlasticity::EshelbianCore::getSpatialDispBc | ( | ) |
[Getting norms]
Definition at line 6778 of file EshelbianPlasticity.cpp.
|
inline |
Definition at line 272 of file EshelbianPlasticity.hpp.
MoFEMErrorCode EshelbianCore::getSpatialTractionBc | ( | ) |
Definition at line 6872 of file EshelbianPlasticity.cpp.
|
inline |
Definition at line 306 of file EshelbianPlasticity.hpp.
MoFEMErrorCode EshelbianPlasticity::EshelbianCore::gettingNorms | ( | ) |
[Getting norms]
Definition at line 6710 of file EshelbianPlasticity.cpp.
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.
meshset | |
bc_ptr | |
disp_block_set_name | |
rot_block_set_name | |
contact_set_name |
Definition at line 2083 of file EshelbianPlasticity.cpp.
Definition at line 164 of file EshelbianPlasticity.hpp.
Definition at line 152 of file EshelbianPlasticity.hpp.
Definition at line 125 of file EshelbianPlasticity.hpp.
Definition at line 165 of file EshelbianPlasticity.hpp.
Definition at line 155 of file EshelbianPlasticity.hpp.
Definition at line 131 of file EshelbianPlasticity.hpp.
Definition at line 163 of file EshelbianPlasticity.hpp.
Definition at line 149 of file EshelbianPlasticity.hpp.
Definition at line 116 of file EshelbianPlasticity.hpp.
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 = {} ) |
Definition at line 3723 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::postProcessSkeletonResults | ( | const int | tag, |
const std::string | file, | ||
Vec | f_residual = PETSC_NULLPTR, | ||
std::vector< Tag > | tags_to_transfer = {} ) |
Definition at line 4217 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::projectGeometry | ( | const EntityHandle | meshset = 0 | ) |
Definition at line 1403 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::query_interface | ( | boost::typeindex::type_index | type_index, |
UnknownInterface ** | iface ) const |
Getting interface of core database.
uuid | unique ID of interface |
iface | returned pointer to interface |
Definition at line 895 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::saveOrgCoords | ( | ) |
Definition at line 6678 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianPlasticity::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 ) |
Definition at line 2317 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::setBlockTagsOnSkin | ( | ) |
Definition at line 3662 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::setContactElementRhsOps | ( | boost::shared_ptr< ContactTree > & | fe_contact_tree | ) |
Contact requires that body is marked
Definition at line 3089 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianPlasticity::EshelbianCore::setElasticElementOps | ( | const int | tag | ) |
Definition at line 3188 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::setElasticElementToTs | ( | DM | dm | ) |
Definition at line 3211 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianPlasticity::EshelbianCore::setFaceElementOps | ( | const bool | add_elastic, |
const bool | add_material, | ||
boost::shared_ptr< FaceElementForcesAndSourcesCore > & | fe_rhs, | ||
boost::shared_ptr< FaceElementForcesAndSourcesCore > & | fe_lhs ) |
Definition at line 2930 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianPlasticity::EshelbianCore::setNewFrontCoordinates | ( | ) |
Definition at line 5902 of file EshelbianPlasticity.cpp.
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 ) |
Contact requires that body is marked
Definition at line 2438 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::solveDynamicRelaxation | ( | TS | ts, |
Vec | x ) |
Definition at line 3571 of file EshelbianPlasticity.cpp.
MoFEMErrorCode EshelbianCore::solveElastic | ( | TS | ts, |
Vec | x ) |
Definition at line 3441 of file EshelbianPlasticity.cpp.
|
friend |
Definition at line 363 of file EshelbianPlasticity.hpp.
std::vector<std::string> EshelbianPlasticity::EshelbianCore::a00FieldList |
Definition at line 447 of file EshelbianPlasticity.hpp.
std::vector<boost::shared_ptr<Range> > EshelbianPlasticity::EshelbianCore::a00RangeList |
Definition at line 449 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 32 of file EshelbianPlasticity.hpp.
double EshelbianPlasticity::EshelbianCore::alphaOmega = 0 |
Definition at line 222 of file EshelbianPlasticity.hpp.
double EshelbianPlasticity::EshelbianCore::alphaRho = 0 |
Definition at line 223 of file EshelbianPlasticity.hpp.
double EshelbianPlasticity::EshelbianCore::alphaU = 0 |
Definition at line 220 of file EshelbianPlasticity.hpp.
double EshelbianPlasticity::EshelbianCore::alphaW = 0 |
Definition at line 221 of file EshelbianPlasticity.hpp.
boost::shared_ptr<AnalyticalExprPython> EshelbianPlasticity::EshelbianCore::AnalyticalExprPythonPtr |
Definition at line 180 of file EshelbianPlasticity.hpp.
AO EshelbianPlasticity::EshelbianCore::aoS = PETSC_NULLPTR |
Definition at line 445 of file EshelbianPlasticity.hpp.
boost::shared_ptr<AnalyticalDisplacementBcVec> EshelbianPlasticity::EshelbianCore::bcSpatialAnalyticalDisplacementVecPtr |
Definition at line 236 of file EshelbianPlasticity.hpp.
boost::shared_ptr<AnalyticalTractionBcVec> EshelbianPlasticity::EshelbianCore::bcSpatialAnalyticalTractionVecPtr |
Definition at line 237 of file EshelbianPlasticity.hpp.
boost::shared_ptr<BcDispVec> EshelbianPlasticity::EshelbianCore::bcSpatialDispVecPtr |
Definition at line 230 of file EshelbianPlasticity.hpp.
boost::shared_ptr<TractionFreeBc> EshelbianPlasticity::EshelbianCore::bcSpatialFreeTractionVecPtr |
Definition at line 233 of file EshelbianPlasticity.hpp.
boost::shared_ptr<NormalDisplacementBcVec> EshelbianPlasticity::EshelbianCore::bcSpatialNormalDisplacementVecPtr |
Definition at line 234 of file EshelbianPlasticity.hpp.
boost::shared_ptr<PressureBcVec> EshelbianPlasticity::EshelbianCore::bcSpatialPressureVecPtr |
Definition at line 238 of file EshelbianPlasticity.hpp.
boost::shared_ptr<BcRotVec> EshelbianPlasticity::EshelbianCore::bcSpatialRotationVecPtr |
Definition at line 231 of file EshelbianPlasticity.hpp.
boost::shared_ptr<TractionBcVec> EshelbianPlasticity::EshelbianCore::bcSpatialTractionVecPtr |
Definition at line 232 of file EshelbianPlasticity.hpp.
BitRefLevel EshelbianPlasticity::EshelbianCore::bitAdjEnt = BitRefLevel().set() |
bit ref level for parent
Definition at line 430 of file EshelbianPlasticity.hpp.
BitRefLevel EshelbianPlasticity::EshelbianCore::bitAdjEntMask |
bit ref level for parent parent
Definition at line 431 of file EshelbianPlasticity.hpp.
BitRefLevel EshelbianPlasticity::EshelbianCore::bitAdjParent = BitRefLevel().set() |
bit ref level for parent
Definition at line 427 of file EshelbianPlasticity.hpp.
BitRefLevel EshelbianPlasticity::EshelbianCore::bitAdjParentMask |
bit ref level for parent parent
Definition at line 428 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::bubbleField = "bubble" |
Definition at line 204 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::contactDisp = "contactDisp" |
Definition at line 201 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::contactElement = "CONTACT" |
Definition at line 210 of file EshelbianPlasticity.hpp.
boost::shared_ptr<Range> EshelbianPlasticity::EshelbianCore::contactFaces |
Definition at line 415 of file EshelbianPlasticity.hpp.
int EshelbianPlasticity::EshelbianCore::contactRefinementLevels = 1 |
Definition at line 225 of file EshelbianPlasticity.hpp.
boost::shared_ptr<ContactTree> EshelbianPlasticity::EshelbianCore::contactTreeRhs |
Make a contact tree.
Definition at line 186 of file EshelbianPlasticity.hpp.
boost::shared_ptr<Range> EshelbianPlasticity::EshelbianCore::crackFaces |
Definition at line 416 of file EshelbianPlasticity.hpp.
SmartPetscObj<IS> EshelbianPlasticity::EshelbianCore::crackHybridIs |
Definition at line 446 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 23 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 24 of file EshelbianPlasticity.hpp.
Definition at line 45 of file EshelbianPlasticity.hpp.
boost::shared_ptr<DataAtIntegrationPts> EshelbianPlasticity::EshelbianCore::dataAtPts |
Definition at line 178 of file EshelbianPlasticity.hpp.
Definition at line 46 of file EshelbianPlasticity.hpp.
SmartPetscObj<DM> EshelbianPlasticity::EshelbianCore::dM |
Coupled problem all fields.
Definition at line 188 of file EshelbianPlasticity.hpp.
SmartPetscObj<DM> EshelbianPlasticity::EshelbianCore::dmElastic |
Elastic problem.
Definition at line 189 of file EshelbianPlasticity.hpp.
SmartPetscObj<DM> EshelbianPlasticity::EshelbianCore::dmMaterial |
Material problem.
Definition at line 190 of file EshelbianPlasticity.hpp.
SmartPetscObj<DM> EshelbianPlasticity::EshelbianCore::dmPrjSpatial |
Projection spatial displacement.
Definition at line 191 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 21 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 29 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 27 of file EshelbianPlasticity.hpp.
CommInterface::EntitiesPetscVector EshelbianPlasticity::EshelbianCore::edgeExchange |
Definition at line 438 of file EshelbianPlasticity.hpp.
boost::shared_ptr<FaceElementForcesAndSourcesCore> EshelbianPlasticity::EshelbianCore::elasticBcLhs |
Definition at line 184 of file EshelbianPlasticity.hpp.
boost::shared_ptr<FaceElementForcesAndSourcesCore> EshelbianPlasticity::EshelbianCore::elasticBcRhs |
Definition at line 185 of file EshelbianPlasticity.hpp.
boost::shared_ptr<VolumeElementForcesAndSourcesCore> EshelbianPlasticity::EshelbianCore::elasticFeLhs |
Definition at line 183 of file EshelbianPlasticity.hpp.
boost::shared_ptr<VolumeElementForcesAndSourcesCore> EshelbianPlasticity::EshelbianCore::elasticFeRhs |
Definition at line 182 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::elementVolumeName = "EP" |
Definition at line 206 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 34 of file EshelbianPlasticity.hpp.
|
static |
Definition at line 43 of file EshelbianPlasticity.hpp.
boost::shared_ptr<ExternalStrainVec> EshelbianPlasticity::EshelbianCore::externalStrainVecPtr |
Definition at line 239 of file EshelbianPlasticity.hpp.
|
static |
Definition at line 44 of file EshelbianPlasticity.hpp.
CommInterface::EntitiesPetscVector EshelbianPlasticity::EshelbianCore::faceExchange |
Definition at line 437 of file EshelbianPlasticity.hpp.
boost::shared_ptr<Range> EshelbianPlasticity::EshelbianCore::frontAdjEdges |
Definition at line 418 of file EshelbianPlasticity.hpp.
boost::shared_ptr<Range> EshelbianPlasticity::EshelbianCore::frontEdges |
Definition at line 417 of file EshelbianPlasticity.hpp.
int EshelbianPlasticity::EshelbianCore::frontLayers = 3 |
Definition at line 226 of file EshelbianPlasticity.hpp.
boost::shared_ptr<Range> EshelbianPlasticity::EshelbianCore::frontVertices |
Definition at line 419 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 17 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Griffith energy.
Definition at line 33 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::hybridSpatialDisp = "hybridSpatialDisp" |
Definition at line 199 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 38 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 36 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 40 of file EshelbianPlasticity.hpp.
Definition at line 48 of file EshelbianPlasticity.hpp.
Definition at line 49 of file EshelbianPlasticity.hpp.
Definition at line 47 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 31 of file EshelbianPlasticity.hpp.
std::vector<Tag> EshelbianPlasticity::EshelbianCore::listTagsToTransfer |
list of tags to transfer to postprocessor
Definition at line 442 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::materialH1Positions = "XH1" |
Definition at line 198 of file EshelbianPlasticity.hpp.
int EshelbianPlasticity::EshelbianCore::materialOrder = 1 |
Definition at line 219 of file EshelbianPlasticity.hpp.
boost::shared_ptr<Range> EshelbianPlasticity::EshelbianCore::materialSkeletonFaces |
Definition at line 421 of file EshelbianPlasticity.hpp.
boost::shared_ptr<Range> EshelbianPlasticity::EshelbianCore::maxMovedFaces |
Definition at line 422 of file EshelbianPlasticity.hpp.
MoFEM::Interface& EshelbianPlasticity::EshelbianCore::mField |
Definition at line 176 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::naturalBcElement = "NATURAL_BC" |
Definition at line 207 of file EshelbianPlasticity.hpp.
int EshelbianPlasticity::EshelbianCore::nbCrackFaces = 0 |
Definition at line 451 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 25 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 19 of file EshelbianPlasticity.hpp.
boost::shared_ptr<ParentFiniteElementAdjacencyFunctionSkeleton<2> > EshelbianPlasticity::EshelbianCore::parentAdjSkeletonFunctionDim2 |
Definition at line 425 of file EshelbianPlasticity.hpp.
boost::shared_ptr<PhysicalEquations> EshelbianPlasticity::EshelbianCore::physicalEquations |
Definition at line 179 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::piolaStress = "P" |
Definition at line 193 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::rotAxis = "omega" |
Definition at line 203 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 16 of file EshelbianPlasticity.hpp.
Mat EshelbianPlasticity::EshelbianCore::S = PETSC_NULLPTR |
Definition at line 444 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 20 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::skeletonElement = "SKELETON" |
Definition at line 209 of file EshelbianPlasticity.hpp.
boost::shared_ptr<Range> EshelbianPlasticity::EshelbianCore::skeletonFaces |
Definition at line 420 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::skinElement = "SKIN" |
Definition at line 208 of file EshelbianPlasticity.hpp.
SmartPetscObj<Vec> EshelbianPlasticity::EshelbianCore::solTSStep |
Definition at line 434 of file EshelbianPlasticity.hpp.
int EshelbianPlasticity::EshelbianCore::spaceH1Order = -1 |
Definition at line 218 of file EshelbianPlasticity.hpp.
int EshelbianPlasticity::EshelbianCore::spaceOrder = 2 |
Definition at line 217 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::spatialH1Disp = "wH1" |
Definition at line 197 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::spatialL2Disp = "wL2" |
Definition at line 195 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 18 of file EshelbianPlasticity.hpp.
const std::string EshelbianPlasticity::EshelbianCore::stretchTensor = "u" |
Definition at line 202 of file EshelbianPlasticity.hpp.
|
inlinestatic |
Definition at line 15 of file EshelbianPlasticity.hpp.
std::map<std::string, boost::shared_ptr<ScalingMethod> > EshelbianPlasticity::EshelbianCore::timeScaleMap |
Definition at line 241 of file EshelbianPlasticity.hpp.
|
inlinestaticconstexpr |
Definition at line 51 of file EshelbianPlasticity.hpp.
|
inlinestaticconstexpr |
Definition at line 52 of file EshelbianPlasticity.hpp.
Definition at line 53 of file EshelbianPlasticity.hpp.
CommInterface::EntitiesPetscVector EshelbianPlasticity::EshelbianCore::vertexExchange |
Definition at line 439 of file EshelbianPlasticity.hpp.
CommInterface::EntitiesPetscVector EshelbianPlasticity::EshelbianCore::volumeExchange |
Definition at line 436 of file EshelbianPlasticity.hpp.