 |
| v0.14.0
|
Go to the documentation of this file.
30 using namespace MoFEM;
31 using namespace boost::multi_index;
32 using namespace boost::multiprecision;
33 using namespace boost::numeric;
38 #include <boost/python.hpp>
39 #include <boost/python/def.hpp>
40 #include <boost/python/numpy.hpp>
41 namespace bp = boost::python;
42 namespace np = boost::python::numpy;
48 static char help[] =
"...\n\n";
50 int main(
int argc,
char *argv[]) {
53 const char param_file[] =
"param_file.petsc";
57 auto core_log = logging::core::get();
65 MOFEM_LOG(
"EP", Sev::inform) <<
"Python initialised";
67 MOFEM_LOG(
"EP", Sev::inform) <<
"Python NOT initialised";
78 PetscBool flg = PETSC_TRUE;
84 char restart_file[255];
85 PetscBool restart_flg = PETSC_TRUE;
92 DMType dm_name =
"DMMOFEM";
94 DMType dm_name_mg =
"DMMOFEM_MG";
101 ParallelComm *pcomm = ParallelComm::get_pcomm(&moab,
MYPCOMM_INDEX);
103 pcomm =
new ParallelComm(&moab, PETSC_COMM_WORLD);
105 PetscBool fully_distributed = PETSC_FALSE;
107 &fully_distributed, PETSC_NULL);
108 if (fully_distributed) {
110 if (pcomm->proc_config().proc_size() == 1)
113 option =
"PARALLEL=READ_PART;"
114 "PARALLEL_RESOLVE_SHARED_ENTS;"
115 "PARTITION=PARALLEL_PARTITION";
139 auto get_adj = [&](
Range ents,
int dim) {
141 CHKERR moab.get_adjacencies(ents, dim,
false, adj,
142 moab::Interface::UNION);
185 const char *list_materials[LastMaterial] = {
186 "stvenant_kirchhoff",
"mooney_rivlin",
"hencky",
"neo_hookean"};
187 PetscInt choice_material = MooneyRivlin;
189 LastMaterial, &choice_material, PETSC_NULL);
191 switch (choice_material) {
192 case StVenantKirchhoff:
193 MOFEM_LOG(
"EP", Sev::inform) <<
"StVenantKirchhoff material model";
198 MOFEM_LOG(
"EP", Sev::inform) <<
"MooneyRivlin material model";
199 MOFEM_LOG(
"EP", Sev::inform) <<
"MU(1, 0)/2 = " <<
MU(1, 0) / 2;
205 MOFEM_LOG(
"EP", Sev::inform) <<
"Hencky material model";
209 MOFEM_LOG(
"EP", Sev::inform) <<
"Neo-Hookean material model";
223 CHKERR VecSetOption(f_elastic, VEC_IGNORE_NEGATIVE_INDICES, PETSC_TRUE);
227 CHKERR PetscViewerBinaryOpen(PETSC_COMM_WORLD, restart_file,
228 FILE_MODE_READ, &viewer);
229 CHKERR VecLoad(x_elastic, viewer);
230 CHKERR PetscViewerDestroy(&viewer);
235 auto ts_elastic =
createTS(PETSC_COMM_WORLD);
236 CHKERR TSSetType(ts_elastic, TSBEULER);
239 CHKERR TSGetAdapt(ts_elastic, &adapt);
240 CHKERR TSAdaptSetType(adapt, TSADAPTNONE);
241 CHKERR TSSetTime(ts_elastic, time);
256 if (Py_FinalizeEx() < 0) {
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.
MoFEMErrorCode addMaterial_HMHMooneyRivlin(const int tape, const double alpha, const double beta, const double lambda, const double sigma_y)
#define MYPCOMM_INDEX
default communicator number PCOMM
auto createTS(MPI_Comm comm)
virtual MPI_Comm & get_comm() const =0
MoFEMErrorCode addBoundaryFiniteElement(const EntityHandle meshset=0)
MoFEMErrorCode addFields(const EntityHandle meshset=0)
PetscErrorCode DMoFEMMeshToLocalVector(DM dm, Vec l, InsertMode mode, ScatterMode scatter_mode)
set local (or ghosted) vector values on mesh for partition only
static MoFEMErrorCode Finalize()
Checks for options to be called at the conclusion of the program.
static boost::shared_ptr< SinkType > createSink(boost::shared_ptr< std::ostream > stream_ptr, std::string comm_filter)
Create a sink object.
MoFEMErrorCode solveElastic(TS ts, Vec x)
Deprecated interface functions.
DeprecatedCoreInterface Interface
PetscErrorCode DMCreateGlobalVector_MoFEM(DM dm, Vec *g)
DMShellSetCreateGlobalVector.
MoFEMErrorCode addMaterial_HMHNeohookean(const int tape, const double c10, const double K)
SmartPetscObj< DM > dmElastic
Elastic problem.
MoFEMErrorCode getSpatialDispBc()
[Getting norms]
#define CHKERR
Inline error check.
implementation of Data Operators for Forces and Sources
MoFEMErrorCode solveDynamicRelaxation(TS ts, Vec x)
auto get_temp_meshset_ptr(moab::Interface &moab)
Create smart pointer to temporary meshset.
MoFEMErrorCode DMRegister_MGViaApproxOrders(const char sname[])
Register DM for Multi-Grid via approximation orders.
static boost::shared_ptr< std::ostream > getStrmSync()
Get the strm sync object.
static boost::shared_ptr< std::ostream > getStrmWorld()
Get the strm world object.
MoFEMErrorCode setBlockTagsOnSkin()
PetscErrorCode DMRegister_MoFEM(const char sname[])
Register MoFEM problem.
MoFEMErrorCode getSpatialRotationBc()
Eshelbian plasticity interface.
MoFEMErrorCode getSpatialTractionFreeBc(const EntityHandle meshset=0)
static MoFEMErrorCode loadFileRootProcAllRestDistributed(moab::Interface &moab, const char *file_name, int dim, LoadFileFun proc_skin_fun=defaultProcSkinFun, const char *options="PARALLEL=BCAST;PARTITION=")
Root proc has whole mesh, other procs only part of it.
MoFEMErrorCode setElasticElementOps(const int tag)
#define MOFEM_LOG_TAG(channel, tag)
Tag channel.
MoFEMErrorCode setElasticElementToTs(DM dm)
static MoFEMErrorCode Initialize(int *argc, char ***args, const char file[], const char help[])
Initializes the MoFEM database PETSc, MOAB and MPI.
#define MOFEM_LOG(channel, severity)
Log.
SmartPetscObj< Vec > vectorDuplicate(Vec vec)
Create duplicate vector of smart vector.
#define CATCH_ERRORS
Catch errors.
static PetscBool dynamicRelaxation
static Range getPartEntities(moab::Interface &moab, int part)
MoFEMErrorCode createExchangeVectors(Sev sev)
MoFEMErrorCode addVolumeFiniteElement(const EntityHandle meshset=0)
MoFEMErrorCode getSpatialTractionBc()
@ MOFEM_DATA_INCONSISTENCY
PetscErrorCode PetscOptionsGetString(PetscOptions *, const char pre[], const char name[], char str[], size_t size, PetscBool *set)
PetscErrorCode PetscOptionsGetEList(PetscOptions *, const char pre[], const char name[], const char *const *list, PetscInt next, PetscInt *value, PetscBool *set)
MoFEMErrorCode addMaterial_Hencky(double E, double nu)
int main(int argc, char *argv[])
MoFEMErrorCode projectGeometry(const EntityHandle meshset=0)
std::bitset< BITREFLEVEL_SIZE > BitRefLevel
Bit structure attached to each entity identifying to what mesh entity is attached.
PetscErrorCode PetscOptionsGetScalar(PetscOptions *, const char pre[], const char name[], PetscScalar *dval, PetscBool *set)
static LoggerType & setLog(const std::string channel)
Set ans resset chanel logger.
MoFEMErrorCode addDMs(const BitRefLevel bit=BitRefLevel().set(0), const EntityHandle meshset=0)
MoFEMErrorCode createCrackSurfaceMeshset()
PetscErrorCode PetscOptionsGetBool(PetscOptions *, const char pre[], const char name[], PetscBool *bval, PetscBool *set)
MoFEMErrorCode addMaterial_HMHHStVenantKirchhoff(const int tape, const double lambda, const double mu, const double sigma_y)
PetscErrorCode TSAdaptCreateMoFEM(TSAdapt adapt)
Craete MOFEM adapt.