 |
| v0.14.0
|
Go to the documentation of this file.
32 static boost::function<
double(
const double)>
f;
39 static double f_log_e(
const double v) {
return std::exp(
v); }
40 static double d_f_log_e(
const double v) {
return std::exp(
v); }
46 static double f_log(
const double v) {
82 UnknownInterface **iface)
const;
142 template <
typename BC>
144 const std::string block_name,
const int nb_attributes) {
149 (boost::format(
"%s(.*)") % block_name).str()
154 std::vector<double> block_attributes;
155 CHKERR it->getAttributes(block_attributes);
156 if (block_attributes.size() < nb_attributes) {
158 "In block %s expected %d attributes, but given %d",
159 it->getName().c_str(), nb_attributes, block_attributes.size());
164 bc_vec_ptr->emplace_back(it->getName(), block_attributes, faces);
189 boost::shared_ptr<TractionFreeBc> &bc_ptr,
190 const std::string contact_set_name);
212 const double sigma_y);
217 const double sigma_y);
225 const int tag,
const bool do_rhs,
const bool do_lhs,
226 const bool calc_rates, SmartPetscObj<Vec> ver_vec,
227 boost::shared_ptr<VolumeElementForcesAndSourcesCore> fe);
230 const int tag,
const bool add_elastic,
const bool add_material,
231 boost::shared_ptr<VolumeElementForcesAndSourcesCore> &fe_rhs,
232 boost::shared_ptr<VolumeElementForcesAndSourcesCore> &fe_lhs);
236 boost::shared_ptr<FaceElementForcesAndSourcesCore> &fe_rhs,
237 boost::shared_ptr<FaceElementForcesAndSourcesCore> &fe_lhs);
241 boost::shared_ptr<ContactTree> &fe_contact_tree
255 Vec f_residual = PETSC_NULL,
256 Vec var_vec = PETSC_NULL,
257 std::vector<Tag> tags_to_transfer = {});
259 const std::string file,
260 Vec f_residual = PETSC_NULL);
292 boost::shared_ptr<ParentFiniteElementAdjacencyFunctionSkeleton<2>>
316 std::vector<boost::shared_ptr<Range>>
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.
const std::string materialL2Disp
MoFEMErrorCode addMaterial_HMHMooneyRivlin(const int tape, const double alpha, const double beta, const double lambda, const double sigma_y)
MoFEMErrorCode setNewFrontCoordinates()
static double inv_d_f_log(const double v)
static double inv_d_f_linear(const double v)
static boost::function< double(const double)> dd_f
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)
BitRefLevel bitAdjParent
bit ref level for parent
std::vector< std::string > a00FieldList
const std::string spatialL2Disp
boost::shared_ptr< Range > contactFaces
static boost::shared_ptr< SetUpSchur > createSetUpSchur(MoFEM::Interface &m_field, EshelbianCore *ep_core_ptr)
static boost::function< double(const double)> f
boost::shared_ptr< VolumeElementForcesAndSourcesCore > elasticFeLhs
boost::shared_ptr< Range > materialSkeletonFaces
boost::shared_ptr< TractionFreeBc > bcSpatialFreeTraction
static PetscBool noStretch
const std::string naturalBcElement
static enum StretchSelector stretchSelector
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
MoFEMErrorCode addBoundaryFiniteElement(const EntityHandle meshset=0)
MoFEMErrorCode saveOrgCoords()
boost::shared_ptr< ContactTree > contactTreeRhs
Make a contact tree.
const std::string materialVolumeElement
MoFEMErrorCode calculateOrientation(const int tag, bool set_orientation)
MoFEMErrorCode postProcessSkeletonResults(const int tag, const std::string file, Vec f_residual=PETSC_NULL)
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 addCrackSurfaces()
MoFEMErrorCode addFields(const EntityHandle meshset=0)
boost::shared_ptr< Range > frontVertices
static double f_linear(const double v)
static double dd_f_log_e(const double v)
boost::shared_ptr< PhysicalEquations > physicalEquations
static double griffithEnergy
Griffith energy.
MoFEMErrorCode solveElastic(TS ts, Vec x)
friend struct solve_elastic_set_up
SmartPetscObj< IS > crackHybridIs
boost::shared_ptr< Range > frontEdges
Deprecated interface functions.
static PetscBool setSingularity
const std::string contactDisp
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)
boost::shared_ptr< Range > skeletonFaces
boost::shared_ptr< Range > maxMovedFaces
static enum RotSelector gradApproximator
MoFEMErrorCode addMaterial_HMHNeohookean(const int tape, const double c10, const double K)
SmartPetscObj< DM > dmElastic
Elastic problem.
MoFEMErrorCode calculateEnergyRelease(const int tag, TS ts)
boost::shared_ptr< ParentFiniteElementAdjacencyFunctionSkeleton< 2 > > parentAdjSkeletonFunctionDim2
MoFEMErrorCode query_interface(boost::typeindex::type_index type_index, UnknownInterface **iface) const
Getting interface of core database.
MoFEM::LogManager::SeverityLevel Sev
MoFEMErrorCode getSpatialDispBc()
[Getting norms]
#define CHKERR
Inline error check.
virtual moab::Interface & get_moab()=0
static double inv_f_linear(const double v)
BitRefLevel bitAdjEnt
bit ref level for parent
const std::string contactElement
MoFEMErrorCode getOptions()
SmartPetscObj< DM > dM
Coupled problem all fields.
const std::string rotAxis
MoFEMErrorCode solveDynamicRelaxation(TS ts, Vec x)
std::vector< Range > TractionFreeBc
const std::string eshelbyStress
virtual MoFEMErrorCode setUp(TS)=0
const std::string materialH1Positions
MoFEMErrorCode gettingNorms()
[Getting norms]
static double inv_dd_f_log(const double v)
const std::string elementVolumeName
static double d_f_log(const double v)
const std::string spatialH1Disp
MoFEMErrorCode setBlockTagsOnSkin()
const std::string materialSkeletonElement
MoFEM::Interface & mField
MoFEMErrorCode getSpatialRotationBc()
BitRefLevel bitAdjEntMask
bit ref level for parent parent
static int addCrackMeshsetId
EshelbianCore(MoFEM::Interface &m_field)
static double exponentBase
MoFEMErrorCode getSpatialTractionFreeBc(const EntityHandle meshset=0)
MoFEMErrorCode setElasticElementOps(const int tag)
const std::string hybridSpatialDisp
const std::string stretchTensor
boost::shared_ptr< BcRotVec > bcSpatialRotationVecPtr
static double inv_f_log_e(const double v)
CommInterface::EntitiesPetscVector faceExchange
static enum SymmetrySelector symmetrySelector
boost::shared_ptr< FaceElementForcesAndSourcesCore > elasticBcRhs
std::vector< boost::shared_ptr< Range > > a00RangeList
BitRefLevel bitAdjParentMask
bit ref level for parent parent
base class for all interface classes
const std::string skeletonElement
MoFEMErrorCode setElasticElementToTs(DM dm)
MoFEMErrorCode setContactElementRhsOps(boost::shared_ptr< ContactTree > &fe_contact_tree)
static double inv_dd_f_log_e(const double v)
std::vector< Tag > listTagsToTransfer
list of tags to transfer to postprocessor
const double v
phase velocity of light in medium (cm/ns)
boost::shared_ptr< VolumeElementForcesAndSourcesCore > elasticFeRhs
static double inv_d_f_log_e(const double v)
static double d_f_log_e(const double v)
static double f_log(const double v)
static PetscBool dynamicRelaxation
MoFEMErrorCode createExchangeVectors(Sev sev)
SmartPetscObj< DM > dmMaterial
Material problem.
MoFEMErrorCode postProcessResults(const int tag, const std::string file, Vec f_residual=PETSC_NULL, Vec var_vec=PETSC_NULL, std::vector< Tag > tags_to_transfer={})
const std::string bubbleField
boost::shared_ptr< Range > frontAdjEdges
static double dd_f_log(const double v)
MoFEMErrorCode addVolumeFiniteElement(const EntityHandle meshset=0)
boost::shared_ptr< TractionBcVec > bcSpatialTraction
const std::string skinElement
static boost::function< double(const double)> inv_f
MoFEMErrorCode getSpatialTractionBc()
const std::string hybridMaterialDisp
CommInterface::EntitiesPetscVector vertexExchange
const FTensor::Tensor2< T, Dim, Dim > Vec
@ MOFEM_DATA_INCONSISTENCY
boost::shared_ptr< BcDispVec > bcSpatialDispVecPtr
boost::shared_ptr< FaceElementForcesAndSourcesCore > elasticBcLhs
CommInterface::EntitiesPetscVector volumeExchange
MoFEMErrorCode setFaceElementOps(const bool add_elastic, const bool add_material, boost::shared_ptr< FaceElementForcesAndSourcesCore > &fe_rhs, boost::shared_ptr< FaceElementForcesAndSourcesCore > &fe_lhs)
const std::string piolaStress
MoFEMErrorCode addMaterial_Hencky(double E, double nu)
static boost::function< double(const double)> inv_d_f
static double inv_dd_f_linear(const double v)
static enum RotSelector rotSelector
MoFEMErrorCode projectGeometry(const EntityHandle meshset=0)
std::bitset< BITREFLEVEL_SIZE > BitRefLevel
Bit structure attached to each entity identifying to what mesh entity is attached.
MoFEMErrorCode getBc(boost::shared_ptr< BC > &bc_vec_ptr, const std::string block_name, const int nb_attributes)
boost::shared_ptr< Range > crackFaces
int contactRefinementLevels
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
static PetscBool crackingOn
static double d_f_linear(const double v)
static double f_log_e(const double v)
SmartPetscObj< Vec > solTSStep
static double dynamicTime
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
SmartPetscObj< DM > dmPrjSpatial
Projection spatial displacement.
static PetscBool l2UserBaseScale
static double dd_f_linear(const double v)
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
MoFEMErrorCode addDMs(const BitRefLevel bit=BitRefLevel().set(0), const EntityHandle meshset=0)
MoFEMErrorCode createCrackSurfaceMeshset()
static boost::function< double(const double)> d_f
static boost::function< double(const double)> inv_dd_f
MoFEMErrorCode addMaterial_HMHHStVenantKirchhoff(const int tape, const double lambda, const double mu, const double sigma_y)
CommInterface::EntitiesPetscVector edgeExchange
static double inv_f_log(const double v)