 |
| v0.14.0
|
Go to the documentation of this file.
11 using namespace MoFEM;
42 constexpr
double rho = 1;
73 CHKERR boundaryCondition();
107 auto project_ho_geometry = [&]() {
109 return mField.loop_dofs(
"GEOMETRY", ent_method);
111 CHKERR project_ho_geometry();
125 simple->getProblemName(),
"U");
146 auto rho_ptr = boost::make_shared<double>(
rho);
148 auto add_rho_block = [
this, rho_ptr](
auto &pip,
auto block_name,
Sev sev) {
152 OpMatRhoBlocks(boost::shared_ptr<double> rho_ptr,
154 std::vector<const CubitMeshSets *> meshset_vec_ptr)
157 "Can not get data from block");
165 for (
auto &b : blockData) {
166 if (b.blockEnts.find(getFEEntityHandle()) != b.blockEnts.end()) {
183 std::vector<BlockData> blockData;
187 std::vector<const CubitMeshSets *> meshset_vec_ptr,
191 for (
auto m : meshset_vec_ptr) {
193 std::vector<double> block_data;
194 CHKERR m->getAttributes(block_data);
195 if (block_data.size() < 1) {
197 "Expected that block has two attributes");
199 auto get_block_ents = [&]() {
202 m_field.
get_moab().get_entities_by_handle(
m->meshset, ents,
true);
207 <<
m->getName() <<
": ro = " << block_data[0];
209 blockData.push_back({block_data[0], get_block_ents()});
216 boost::shared_ptr<double> rhoPtr;
219 pip.push_back(
new OpMatRhoBlocks(
220 rho_ptr, mField, sev,
225 (boost::format(
"%s(.*)") % block_name).str()
239 auto get_time_scale = [
this](
const double time) {
240 return sin(time *
omega * M_PI);
243 auto apply_lhs = [&](
auto &pip) {
247 CHKERR HenckyOps::opFactoryDomainLhs<SPACE_DIM, PETSC, GAUSS, DomainEleOp>(
248 mField, pip,
"U",
"MAT_ELASTIC", Sev::verbose);
249 CHKERR add_rho_block(pip,
"MAT_RHO", Sev::verbose);
251 pip.push_back(
new OpMass(
"U",
"U", get_rho));
252 static_cast<OpMass &
>(pip.back()).feScalingFun =
257 auto apply_rhs = [&](
auto &pip) {
261 pipeline_mng->getOpDomainRhsPipeline(), {H1},
"GEOMETRY");
262 CHKERR HenckyOps::opFactoryDomainRhs<SPACE_DIM, PETSC, GAUSS, DomainEleOp>(
263 mField, pip,
"U",
"MAT_ELASTIC", Sev::inform);
264 CHKERR add_rho_block(pip,
"MAT_RHO", Sev::inform);
266 auto mat_acceleration_ptr = boost::make_shared<MatrixDouble>();
269 "U", mat_acceleration_ptr));
270 pip.push_back(
new OpInertiaForce(
"U", mat_acceleration_ptr, get_rho));
273 pip, mField,
"U", {},
274 {boost::make_shared<TimeScaleVector<SPACE_DIM>>(
"-time_vector_file",
276 "BODY_FORCE", Sev::inform);
281 CHKERR apply_lhs(pipeline_mng->getOpDomainLhsPipeline());
282 CHKERR apply_rhs(pipeline_mng->getOpDomainRhsPipeline());
290 auto get_bc_hook = [&]() {
292 mField, pipeline_mng->getDomainRhsFE(),
293 {boost::make_shared<TimeScale>()});
297 pipeline_mng->getDomainRhsFE()->preProcessHook = get_bc_hook();
311 : dM(dm), postProc(post_proc){};
317 CHKERR postProc->writeFile(
318 "out_step_" + boost::lexical_cast<std::string>(ts_step) +
".h5m");
325 boost::shared_ptr<PostProcEle> postProc;
334 auto dm =
simple->getDM();
336 ts = pipeline_mng->createTSIM2();
339 auto post_proc_fe = boost::make_shared<PostProcEle>(mField);
341 post_proc_fe->getOpPtrVector(), {H1});
342 auto common_ptr = commonDataFactory<SPACE_DIM, GAUSS, DomainEleOp>(
343 mField, post_proc_fe->getOpPtrVector(),
"U",
"MAT_ELASTIC", Sev::inform);
345 auto u_ptr = boost::make_shared<MatrixDouble>();
346 post_proc_fe->getOpPtrVector().push_back(
348 auto X_ptr = boost::make_shared<MatrixDouble>();
349 post_proc_fe->getOpPtrVector().push_back(
354 post_proc_fe->getOpPtrVector().push_back(
358 post_proc_fe->getPostProcMesh(), post_proc_fe->getMapGaussPts(),
362 {{
"U", u_ptr}, {
"GEOMETRY", X_ptr}},
364 {{
"GRAD", common_ptr->matGradPtr},
365 {
"FIRST_PIOLA", common_ptr->getMatFirstPiolaStress()}},
374 boost::shared_ptr<FEMethod> null_fe;
375 auto monitor_ptr = boost::make_shared<Monitor>(dm, post_proc_fe);
377 null_fe, monitor_ptr);
381 CHKERR TSSetExactFinalTime(ts, TS_EXACTFINALTIME_MATCHSTEP);
387 CHKERR TS2SetSolution(ts, T, TT);
388 CHKERR TSSetFromOptions(ts);
391 CHKERR TSGetTime(ts, &ftime);
393 PetscInt steps, snesfails, rejects, nonlinits, linits;
394 #if PETSC_VERSION_GE(3, 8, 0)
395 CHKERR TSGetStepNumber(ts, &steps);
397 CHKERR TSGetTimeStepNumber(ts, &steps);
399 CHKERR TSGetSNESFailures(ts, &snesfails);
400 CHKERR TSGetStepRejections(ts, &rejects);
401 CHKERR TSGetSNESIterations(ts, &nonlinits);
402 CHKERR TSGetKSPIterations(ts, &linits);
404 "steps %d (%d rejected, %d SNES fails), ftime %g, nonlinits "
406 steps, rejects, snesfails, ftime, nonlinits, linits);
415 PetscBool test_flg = PETSC_FALSE;
423 CHKERR VecNorm(T, NORM_2, &nrm2);
424 MOFEM_LOG(
"EXAMPLE", Sev::inform) <<
"Regression norm " << nrm2;
425 constexpr
double regression_value = 0.0194561;
426 if (fabs(nrm2 - regression_value) > 1e-2)
428 "Regression test failed; wrong norm value.");
441 static char help[] =
"...\n\n";
443 int main(
int argc,
char *argv[]) {
446 const char param_file[] =
"param_file.petsc";
450 auto core_log = logging::core::get();
459 DMType dm_name =
"DMMOFEM";
#define MoFEMFunctionReturnHot(a)
Last executable line of each PETSc function used for error handling. Replaces return()
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.
Data on single entity (This is passed as argument to DataOperator::doWork)
MoFEMErrorCode checkResults()
[Postprocess results]
#define EXECUTABLE_DIMENSION
Monitor(SmartPetscObj< DM > dm, boost::shared_ptr< PostProcEle > post_proc)
MoFEMErrorCode assembleSystem()
[Push operators to pipeline]
Example(MoFEM::Interface &m_field)
#define MOFEM_LOG_CHANNEL(channel)
Set and reset channel.
structure for User Loop Methods on finite elements
#define CHK_THROW_MESSAGE(err, msg)
Check and throw MoFEM exception.
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpMass< 1, SPACE_DIM > OpMass
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
Get values at integration pts for tensor filed rank 1, i.e. vector field.
PipelineManager interface.
PetscErrorCode DMoFEMMeshToLocalVector(DM dm, Vec l, InsertMode mode, ScatterMode scatter_mode)
set local (or ghosted) vector values on mesh for partition only
Definition of the displacement bc data structure.
Projection of edge entities with one mid-node on hierarchical basis.
static MoFEMErrorCode Finalize()
Checks for options to be called at the conclusion of the program.
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpBaseTimesVector< 1, SPACE_DIM, 1 > OpInertiaForce
static boost::shared_ptr< SinkType > createSink(boost::shared_ptr< std::ostream > stream_ptr, std::string comm_filter)
Create a sink object.
MoFEMErrorCode postProcess()
function is run at the end of loop
Simple interface for fast problem set-up.
Deprecated interface functions.
DeprecatedCoreInterface Interface
Approximate field values for given petsc vector.
MoFEMErrorCode readMesh()
[Run problem]
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpBaseTimesVector< 1, SPACE_DIM, 1 > OpInertiaForce
static char help[]
[Check]
#define CHKERR
Inline error check.
auto createDMVector(DM dm)
Get smart vector from DM.
Specialization for DisplacementCubitBcData.
virtual moab::Interface & get_moab()=0
implementation of Data Operators for Forces and Sources
Simple interface for fast problem set-up.
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpMass< 1, SPACE_DIM > OpMass
[Only used with Hooke equation (linear material model)]
#define MOFEM_LOG_C(channel, severity, format,...)
void simple(double P1[], double P2[], double P3[], double c[], const int N)
OpPostProcMapInMoab< SPACE_DIM, SPACE_DIM > OpPPMap
MoFEMErrorCode solveSystem()
[Solve]
int main(int argc, char *argv[])
static boost::shared_ptr< std::ostream > getStrmWorld()
Get the strm world object.
PetscErrorCode DMRegister_MoFEM(const char sname[])
Register MoFEM problem.
SeverityLevel
Severity levels.
#define MOFEM_LOG_TAG(channel, tag)
Tag channel.
Volume finite element base.
FTensor::Index< 'i', SPACE_DIM > i
@ AINSWORTH_BERNSTEIN_BEZIER_BASE
Add operators pushing bases from local to physical configuration.
static MoFEMErrorCode Initialize(int *argc, char ***args, const char file[], const char help[])
Initializes the MoFEM database PETSc, MOAB and MPI.
#define MOFEM_TAG_AND_LOG(channel, severity, tag)
Tag and log in channel.
#define MOFEM_LOG(channel, severity)
Log.
SmartPetscObj< Vec > vectorDuplicate(Vec vec)
Create duplicate vector of smart vector.
#define CATCH_ERRORS
Catch errors.
PetscReal ts_aa
shift for U_tt shift for U_tt
MoFEMErrorCode setupProblem()
[Run problem]
constexpr double poisson_ratio
ForcesAndSourcesCore::UserDataOperator UserDataOperator
EntitiesFieldData::EntData EntData
MoFEMErrorCode boundaryCondition()
[Set up problem]
[Push operators to pipeline]
PetscErrorCode DMMoFEMTSSetMonitor(DM dm, TS ts, const std::string fe_name, boost::shared_ptr< MoFEM::FEMethod > method, boost::shared_ptr< MoFEM::BasicMethod > pre_only, boost::shared_ptr< MoFEM::BasicMethod > post_only)
Set Monitor To TS solver.
@ AINSWORTH_LEGENDRE_BASE
Ainsworth Cole (Legendre) approx. base .
@ MOFEM_DATA_INCONSISTENCY
Interface for managing meshsets containing materials and boundary conditions.
MoFEMErrorCode runProblem()
[Run problem]
FTensor::Index< 'm', 3 > m
@ MOFEM_ATOM_TEST_INVALID
ElementsAndOps< SPACE_DIM >::DomainEle DomainEle
MoFEMErrorCode getCubitMeshsetPtr(const int ms_id, const CubitBCType cubit_bc_type, const CubitMeshSets **cubit_meshset_ptr) const
get cubit meshset
static LoggerType & setLog(const std::string channel)
Set ans resset chanel logger.
MoFEMErrorCode outputResults()
[Solve]
PetscErrorCode DMoFEMLoopFiniteElements(DM dm, const char fe_name[], MoFEM::FEMethod *method, CacheTupleWeakPtr cache_ptr=CacheTupleSharedPtr())
Executes FEMethod for finite elements in DM.
PetscErrorCode PetscOptionsGetInt(PetscOptions *, const char pre[], const char name[], PetscInt *ivalue, PetscBool *set)
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
PetscErrorCode PetscOptionsGetBool(PetscOptions *, const char pre[], const char name[], PetscBool *bval, PetscBool *set)
Post post-proc data at points from hash maps.
constexpr double young_modulus