![]() |
v0.15.0 |
#include "users_modules/eshelbian_plasticity/src/EshelbianCore.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 () |
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 () |
![]() | |
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 |
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 |
Definition at line 12 of file EshelbianCore.hpp.
EshelbianCore::EshelbianCore | ( | MoFEM::Interface & | m_field | ) |
|
virtual |
MoFEMErrorCode EshelbianCore::addBoundaryFiniteElement | ( | const EntityHandle | meshset = 0 | ) |
MoFEMErrorCode EshelbianCore::addCrackSurfaces | ( | const bool | debug = false | ) |
MoFEMErrorCode EshelbianCore::addDMs | ( | const BitRefLevel | bit = BitRefLevel().set(0), |
const EntityHandle | meshset = 0 ) |
MoFEMErrorCode EshelbianCore::addFields | ( | const EntityHandle | meshset = 0 | ) |
MoFEMErrorCode EshelbianCore::addMaterial_HMHHStVenantKirchhoff | ( | const int | tape, |
const double | lambda, | ||
const double | mu, | ||
const double | sigma_y ) |
MoFEMErrorCode EshelbianCore::addMaterial_HMHMooneyRivlin | ( | const int | tape, |
const double | alpha, | ||
const double | beta, | ||
const double | lambda, | ||
const double | sigma_y ) |
MoFEMErrorCode EshelbianCore::addMaterial_HMHNeohookean | ( | const int | tape, |
const double | c10, | ||
const double | K ) |
MoFEMErrorCode EshelbianCore::addVolumeFiniteElement | ( | const EntityHandle | meshset = 0 | ) |
MoFEMErrorCode EshelbianCore::calculateCrackArea | ( | boost::shared_ptr< double > | area_ptr | ) |
MoFEMErrorCode EshelbianCore::calculateFaceMaterialForce | ( | const int | tag, |
TS | ts ) |
MoFEMErrorCode EshelbianCore::calculateOrientation | ( | const int | tag, |
bool | set_orientation ) |
MoFEMErrorCode EshelbianCore::createCrackSurfaceMeshset | ( | ) |
MoFEMErrorCode EshelbianCore::createExchangeVectors | ( | Sev | sev | ) |
Definition at line 95 of file EshelbianCore.hpp.
Definition at line 64 of file EshelbianCore.hpp.
Definition at line 105 of file EshelbianCore.hpp.
Definition at line 74 of file EshelbianCore.hpp.
Definition at line 137 of file EshelbianCore.hpp.
Definition at line 82 of file EshelbianCore.hpp.
Definition at line 54 of file EshelbianCore.hpp.
|
inline |
Definition at line 243 of file EshelbianCore.hpp.
MoFEMErrorCode EshelbianCore::getExternalStrain | ( | ) |
MoFEMErrorCode EshelbianCore::getOptions | ( | ) |
MoFEMErrorCode EshelbianCore::getSpatialDispBc | ( | ) |
|
inline |
Definition at line 271 of file EshelbianCore.hpp.
MoFEMErrorCode EshelbianCore::getSpatialTractionBc | ( | ) |
|
inline |
Definition at line 305 of file EshelbianCore.hpp.
MoFEMErrorCode EshelbianCore::gettingNorms | ( | ) |
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 151 of file EshelbianCore.hpp.
Definition at line 124 of file EshelbianCore.hpp.
Definition at line 154 of file EshelbianCore.hpp.
Definition at line 148 of file EshelbianCore.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 = {} ) |
MoFEMErrorCode EshelbianCore::postProcessSkeletonResults | ( | const int | tag, |
const std::string | file, | ||
Vec | f_residual = PETSC_NULLPTR, | ||
std::vector< Tag > | tags_to_transfer = {} ) |
MoFEMErrorCode EshelbianCore::projectGeometry | ( | const EntityHandle | meshset = 0 | ) |
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 |
MoFEMErrorCode EshelbianCore::saveOrgCoords | ( | ) |
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 ) |
MoFEMErrorCode EshelbianCore::setBlockTagsOnSkin | ( | ) |
MoFEMErrorCode EshelbianCore::setContactElementRhsOps | ( | boost::shared_ptr< ContactTree > & | fe_contact_tree | ) |
MoFEMErrorCode EshelbianCore::setElasticElementOps | ( | const int | tag | ) |
MoFEMErrorCode EshelbianCore::setElasticElementToTs | ( | DM | dm | ) |
MoFEMErrorCode EshelbianCore::setFaceElementOps | ( | const bool | add_elastic, |
const bool | add_material, | ||
boost::shared_ptr< FaceElementForcesAndSourcesCore > & | fe_rhs, | ||
boost::shared_ptr< FaceElementForcesAndSourcesCore > & | fe_lhs ) |
MoFEMErrorCode EshelbianCore::setNewFrontCoordinates | ( | ) |
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 ) |
MoFEMErrorCode EshelbianCore::solveDynamicRelaxation | ( | TS | ts, |
Vec | x ) |
MoFEMErrorCode EshelbianCore::solveElastic | ( | TS | ts, |
Vec | x ) |
|
friend |
Definition at line 362 of file EshelbianCore.hpp.
std::vector<std::string> EshelbianCore::a00FieldList |
Definition at line 446 of file EshelbianCore.hpp.
std::vector<boost::shared_ptr<Range> > EshelbianCore::a00RangeList |
Definition at line 448 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 31 of file EshelbianCore.hpp.
double EshelbianCore::alphaOmega = 0 |
Definition at line 221 of file EshelbianCore.hpp.
double EshelbianCore::alphaRho = 0 |
Definition at line 222 of file EshelbianCore.hpp.
double EshelbianCore::alphaU = 0 |
Definition at line 219 of file EshelbianCore.hpp.
double EshelbianCore::alphaW = 0 |
Definition at line 220 of file EshelbianCore.hpp.
boost::shared_ptr<AnalyticalExprPython> EshelbianCore::AnalyticalExprPythonPtr |
Definition at line 179 of file EshelbianCore.hpp.
AO EshelbianCore::aoS = PETSC_NULLPTR |
Definition at line 444 of file EshelbianCore.hpp.
boost::shared_ptr<AnalyticalDisplacementBcVec> EshelbianCore::bcSpatialAnalyticalDisplacementVecPtr |
Definition at line 235 of file EshelbianCore.hpp.
boost::shared_ptr<AnalyticalTractionBcVec> EshelbianCore::bcSpatialAnalyticalTractionVecPtr |
Definition at line 236 of file EshelbianCore.hpp.
boost::shared_ptr<BcDispVec> EshelbianCore::bcSpatialDispVecPtr |
Definition at line 229 of file EshelbianCore.hpp.
boost::shared_ptr<TractionFreeBc> EshelbianCore::bcSpatialFreeTractionVecPtr |
Definition at line 232 of file EshelbianCore.hpp.
boost::shared_ptr<NormalDisplacementBcVec> EshelbianCore::bcSpatialNormalDisplacementVecPtr |
Definition at line 233 of file EshelbianCore.hpp.
boost::shared_ptr<PressureBcVec> EshelbianCore::bcSpatialPressureVecPtr |
Definition at line 237 of file EshelbianCore.hpp.
boost::shared_ptr<BcRotVec> EshelbianCore::bcSpatialRotationVecPtr |
Definition at line 230 of file EshelbianCore.hpp.
boost::shared_ptr<TractionBcVec> EshelbianCore::bcSpatialTractionVecPtr |
Definition at line 231 of file EshelbianCore.hpp.
BitRefLevel EshelbianCore::bitAdjEnt = BitRefLevel().set() |
bit ref level for parent
Definition at line 429 of file EshelbianCore.hpp.
BitRefLevel EshelbianCore::bitAdjEntMask |
bit ref level for parent parent
Definition at line 430 of file EshelbianCore.hpp.
BitRefLevel EshelbianCore::bitAdjParent = BitRefLevel().set() |
bit ref level for parent
Definition at line 426 of file EshelbianCore.hpp.
BitRefLevel EshelbianCore::bitAdjParentMask |
bit ref level for parent parent
Definition at line 427 of file EshelbianCore.hpp.
const std::string EshelbianCore::bubbleField = "bubble" |
Definition at line 203 of file EshelbianCore.hpp.
const std::string EshelbianCore::contactDisp = "contactDisp" |
Definition at line 200 of file EshelbianCore.hpp.
const std::string EshelbianCore::contactElement = "CONTACT" |
Definition at line 209 of file EshelbianCore.hpp.
boost::shared_ptr<Range> EshelbianCore::contactFaces |
Definition at line 414 of file EshelbianCore.hpp.
int EshelbianCore::contactRefinementLevels = 1 |
Definition at line 224 of file EshelbianCore.hpp.
boost::shared_ptr<ContactTree> EshelbianCore::contactTreeRhs |
Make a contact tree.
Definition at line 185 of file EshelbianCore.hpp.
boost::shared_ptr<Range> EshelbianCore::crackFaces |
Definition at line 415 of file EshelbianCore.hpp.
SmartPetscObj<IS> EshelbianCore::crackHybridIs |
Definition at line 445 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 22 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 23 of file EshelbianCore.hpp.
Definition at line 44 of file EshelbianCore.hpp.
boost::shared_ptr<DataAtIntegrationPts> EshelbianCore::dataAtPts |
Definition at line 177 of file EshelbianCore.hpp.
Definition at line 45 of file EshelbianCore.hpp.
SmartPetscObj<DM> EshelbianCore::dM |
Coupled problem all fields.
Definition at line 187 of file EshelbianCore.hpp.
SmartPetscObj<DM> EshelbianCore::dmElastic |
Elastic problem.
Definition at line 188 of file EshelbianCore.hpp.
SmartPetscObj<DM> EshelbianCore::dmMaterial |
Material problem.
Definition at line 189 of file EshelbianCore.hpp.
SmartPetscObj<DM> EshelbianCore::dmPrjSpatial |
Projection spatial displacement.
Definition at line 190 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 20 of file EshelbianCore.hpp.
|
inlinestatic |
|
inlinestatic |
CommInterface::EntitiesPetscVector EshelbianCore::edgeExchange |
Definition at line 437 of file EshelbianCore.hpp.
boost::shared_ptr<FaceElementForcesAndSourcesCore> EshelbianCore::elasticBcLhs |
Definition at line 183 of file EshelbianCore.hpp.
boost::shared_ptr<FaceElementForcesAndSourcesCore> EshelbianCore::elasticBcRhs |
Definition at line 184 of file EshelbianCore.hpp.
boost::shared_ptr<VolumeElementForcesAndSourcesCore> EshelbianCore::elasticFeLhs |
Definition at line 182 of file EshelbianCore.hpp.
boost::shared_ptr<VolumeElementForcesAndSourcesCore> EshelbianCore::elasticFeRhs |
Definition at line 181 of file EshelbianCore.hpp.
const std::string EshelbianCore::elementVolumeName = "EP" |
Definition at line 205 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 33 of file EshelbianCore.hpp.
|
static |
Definition at line 42 of file EshelbianCore.hpp.
boost::shared_ptr<ExternalStrainVec> EshelbianCore::externalStrainVecPtr |
Definition at line 238 of file EshelbianCore.hpp.
Definition at line 43 of file EshelbianCore.hpp.
CommInterface::EntitiesPetscVector EshelbianCore::faceExchange |
Definition at line 436 of file EshelbianCore.hpp.
boost::shared_ptr<Range> EshelbianCore::frontAdjEdges |
Definition at line 417 of file EshelbianCore.hpp.
boost::shared_ptr<Range> EshelbianCore::frontEdges |
Definition at line 416 of file EshelbianCore.hpp.
int EshelbianCore::frontLayers = 3 |
Definition at line 225 of file EshelbianCore.hpp.
boost::shared_ptr<Range> EshelbianCore::frontVertices |
Definition at line 418 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 16 of file EshelbianCore.hpp.
|
inlinestatic |
const std::string EshelbianCore::hybridSpatialDisp = "hybridSpatialDisp" |
Definition at line 198 of file EshelbianCore.hpp.
|
inlinestatic |
|
inlinestatic |
Definition at line 35 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 39 of file EshelbianCore.hpp.
Definition at line 47 of file EshelbianCore.hpp.
Definition at line 48 of file EshelbianCore.hpp.
Definition at line 46 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 30 of file EshelbianCore.hpp.
std::vector<Tag> EshelbianCore::listTagsToTransfer |
list of tags to transfer to postprocessor
Definition at line 441 of file EshelbianCore.hpp.
const std::string EshelbianCore::materialH1Positions = "XH1" |
Definition at line 197 of file EshelbianCore.hpp.
int EshelbianCore::materialOrder = 1 |
Definition at line 218 of file EshelbianCore.hpp.
boost::shared_ptr<Range> EshelbianCore::materialSkeletonFaces |
Definition at line 420 of file EshelbianCore.hpp.
boost::shared_ptr<Range> EshelbianCore::maxMovedFaces |
Definition at line 421 of file EshelbianCore.hpp.
MoFEM::Interface& EshelbianCore::mField |
Definition at line 175 of file EshelbianCore.hpp.
const std::string EshelbianCore::naturalBcElement = "NATURAL_BC" |
Definition at line 206 of file EshelbianCore.hpp.
int EshelbianCore::nbCrackFaces = 0 |
Definition at line 450 of file EshelbianCore.hpp.
|
inlinestatic |
|
inlinestatic |
Definition at line 18 of file EshelbianCore.hpp.
boost::shared_ptr<ParentFiniteElementAdjacencyFunctionSkeleton<2> > EshelbianCore::parentAdjSkeletonFunctionDim2 |
Definition at line 424 of file EshelbianCore.hpp.
boost::shared_ptr<PhysicalEquations> EshelbianCore::physicalEquations |
Definition at line 178 of file EshelbianCore.hpp.
const std::string EshelbianCore::piolaStress = "P" |
Definition at line 192 of file EshelbianCore.hpp.
const std::string EshelbianCore::rotAxis = "omega" |
Definition at line 202 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 15 of file EshelbianCore.hpp.
Mat EshelbianCore::S = PETSC_NULLPTR |
Definition at line 443 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 19 of file EshelbianCore.hpp.
const std::string EshelbianCore::skeletonElement = "SKELETON" |
Definition at line 208 of file EshelbianCore.hpp.
boost::shared_ptr<Range> EshelbianCore::skeletonFaces |
Definition at line 419 of file EshelbianCore.hpp.
const std::string EshelbianCore::skinElement = "SKIN" |
Definition at line 207 of file EshelbianCore.hpp.
SmartPetscObj<Vec> EshelbianCore::solTSStep |
Definition at line 433 of file EshelbianCore.hpp.
int EshelbianCore::spaceH1Order = -1 |
Definition at line 217 of file EshelbianCore.hpp.
int EshelbianCore::spaceOrder = 2 |
Definition at line 216 of file EshelbianCore.hpp.
const std::string EshelbianCore::spatialH1Disp = "wH1" |
Definition at line 196 of file EshelbianCore.hpp.
const std::string EshelbianCore::spatialL2Disp = "wL2" |
Definition at line 194 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 17 of file EshelbianCore.hpp.
const std::string EshelbianCore::stretchTensor = "u" |
Definition at line 201 of file EshelbianCore.hpp.
|
inlinestatic |
Definition at line 14 of file EshelbianCore.hpp.
std::map<std::string, boost::shared_ptr<ScalingMethod> > EshelbianCore::timeScaleMap |
Definition at line 240 of file EshelbianCore.hpp.
|
inlinestaticconstexpr |
Definition at line 50 of file EshelbianCore.hpp.
|
inlinestaticconstexpr |
Definition at line 51 of file EshelbianCore.hpp.
Definition at line 52 of file EshelbianCore.hpp.
CommInterface::EntitiesPetscVector EshelbianCore::vertexExchange |
Definition at line 438 of file EshelbianCore.hpp.
CommInterface::EntitiesPetscVector EshelbianCore::volumeExchange |
Definition at line 435 of file EshelbianCore.hpp.