v0.14.0
nonlinear_dynamic_elastic.cpp
Go to the documentation of this file.
1 /**
2  * \file dynamic_elastic.cpp
3  * \example dynamic_elastic.cpp
4  *
5  * Plane stress elastic dynamic problem
6  *
7  */
8 
9 #include <MoFEM.hpp>
10 #include <MatrixFunction.hpp>
11 using namespace MoFEM;
12 
13 template <int DIM> struct ElementsAndOps {};
14 
15 template <> struct ElementsAndOps<2> {
17 };
18 
19 template <> struct ElementsAndOps<3> {
21 };
22 
23 constexpr int SPACE_DIM =
24  EXECUTABLE_DIMENSION; //< Space dimension of problem, mesh
25 
30 
34  PETSC>::LinearForm<GAUSS>::OpBaseTimesVector<1, SPACE_DIM, 1>;
35 
36 using DomainNaturalBC =
38 using OpBodyForceVector =
41 
42 constexpr double rho = 1;
43 constexpr double omega = 2.4;
44 constexpr double young_modulus = 1;
45 constexpr double poisson_ratio = 0.25;
46 
47 #include <HenckyOps.hpp>
48 using namespace HenckyOps;
49 
50 struct Example {
51 
52  Example(MoFEM::Interface &m_field) : mField(m_field) {}
53 
54  MoFEMErrorCode runProblem();
55 
56 private:
57  MoFEM::Interface &mField;
58 
59  MoFEMErrorCode readMesh();
60  MoFEMErrorCode setupProblem();
61  MoFEMErrorCode boundaryCondition();
62  MoFEMErrorCode assembleSystem();
63  MoFEMErrorCode solveSystem();
64  MoFEMErrorCode outputResults();
65  MoFEMErrorCode checkResults();
66 };
67 
68 //! [Run problem]
71  CHKERR readMesh();
72  CHKERR setupProblem();
73  CHKERR boundaryCondition();
74  CHKERR assembleSystem();
75  CHKERR solveSystem();
76  CHKERR outputResults();
77  CHKERR checkResults();
79 }
80 //! [Run problem]
81 
82 //! [Read mesh]
85  auto simple = mField.getInterface<Simple>();
86  CHKERR simple->getOptions();
87  CHKERR simple->loadFile();
89 }
90 //! [Read mesh]
91 
92 //! [Set up problem]
95  Simple *simple = mField.getInterface<Simple>();
96  // Add field
97  CHKERR simple->addDomainField("U", H1, AINSWORTH_BERNSTEIN_BEZIER_BASE,
98  SPACE_DIM);
99  CHKERR simple->addDataField("GEOMETRY", H1, AINSWORTH_LEGENDRE_BASE,
100  SPACE_DIM);
101  int order = 2;
102  CHKERR PetscOptionsGetInt(PETSC_NULL, "", "-order", &order, PETSC_NULL);
103  CHKERR simple->setFieldOrder("U", order);
104  CHKERR simple->setFieldOrder("GEOMETRY", order);
105  CHKERR simple->setUp();
106 
107  auto project_ho_geometry = [&]() {
108  Projection10NodeCoordsOnField ent_method(mField, "GEOMETRY");
109  return mField.loop_dofs("GEOMETRY", ent_method);
110  };
111  CHKERR project_ho_geometry();
112 
114 }
115 //! [Set up problem]
116 
117 //! [Boundary condition]
120 
121  auto simple = mField.getInterface<Simple>();
122  auto bc_mng = mField.getInterface<BcManager>();
123 
124  CHKERR bc_mng->removeBlockDOFsOnEntities<DisplacementCubitBcData>(
125  simple->getProblemName(), "U");
126 
128 }
129 //! [Boundary condition]
130 
131 //! [Push operators to pipeline]
134  auto *simple = mField.getInterface<Simple>();
135  auto *pipeline_mng = mField.getInterface<PipelineManager>();
136 
137  auto get_body_force = [this](const double, const double, const double) {
140  t_source(i) = 0.;
141  t_source(0) = 0.1;
142  t_source(1) = 1.;
143  return t_source;
144  };
145 
146  auto rho_ptr = boost::make_shared<double>(rho);
147 
148  auto add_rho_block = [this, rho_ptr](auto &pip, auto block_name, Sev sev) {
150 
151  struct OpMatRhoBlocks : public DomainEleOp {
152  OpMatRhoBlocks(boost::shared_ptr<double> rho_ptr,
153  MoFEM::Interface &m_field, Sev sev,
154  std::vector<const CubitMeshSets *> meshset_vec_ptr)
155  : DomainEleOp(NOSPACE, DomainEleOp::OPSPACE), rhoPtr(rho_ptr) {
156  CHK_THROW_MESSAGE(extractRhoData(m_field, meshset_vec_ptr, sev),
157  "Can not get data from block");
158  }
159 
160  MoFEMErrorCode doWork(int side, EntityType type,
162 
164 
165  for (auto &b : blockData) {
166  if (b.blockEnts.find(getFEEntityHandle()) != b.blockEnts.end()) {
167  *rhoPtr = b.rho;
169  }
170  }
171 
172  *rhoPtr = rho;
173 
175  }
176 
177  private:
178  struct BlockData {
179  double rho;
180  Range blockEnts;
181  };
182 
183  std::vector<BlockData> blockData;
184 
186  extractRhoData(MoFEM::Interface &m_field,
187  std::vector<const CubitMeshSets *> meshset_vec_ptr,
188  Sev sev) {
190 
191  for (auto m : meshset_vec_ptr) {
192  MOFEM_TAG_AND_LOG("WORLD", sev, "Mat Rho Block") << *m;
193  std::vector<double> block_data;
194  CHKERR m->getAttributes(block_data);
195  if (block_data.size() < 1) {
196  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
197  "Expected that block has two attributes");
198  }
199  auto get_block_ents = [&]() {
200  Range ents;
201  CHKERR
202  m_field.get_moab().get_entities_by_handle(m->meshset, ents, true);
203  return ents;
204  };
205 
206  MOFEM_TAG_AND_LOG("WORLD", sev, "Mat Rho Block")
207  << m->getName() << ": ro = " << block_data[0];
208 
209  blockData.push_back({block_data[0], get_block_ents()});
210  }
211  MOFEM_LOG_CHANNEL("WORLD");
212  MOFEM_LOG_CHANNEL("WORLD");
214  }
215 
216  boost::shared_ptr<double> rhoPtr;
217  };
218 
219  pip.push_back(new OpMatRhoBlocks(
220  rho_ptr, mField, sev,
221 
222  // Get blockset using regular expression
223  mField.getInterface<MeshsetsManager>()->getCubitMeshsetPtr(std::regex(
224 
225  (boost::format("%s(.*)") % block_name).str()
226 
227  ))
228 
229  ));
231  };
232 
233  // Get pointer to U_tt shift in domain element
234  auto get_rho = [rho_ptr](const double, const double, const double) {
235  return *rho_ptr;
236  };
237 
238  // specific time scaling
239  auto get_time_scale = [this](const double time) {
240  return sin(time * omega * M_PI);
241  };
242 
243  auto apply_lhs = [&](auto &pip) {
246  "GEOMETRY");
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);
250 
251  pip.push_back(new OpMass("U", "U", get_rho));
252  static_cast<OpMass &>(pip.back()).feScalingFun =
253  [](const FEMethod *fe_ptr) { return fe_ptr->ts_aa; };
255  };
256 
257  auto apply_rhs = [&](auto &pip) {
259 
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);
265 
266  auto mat_acceleration_ptr = boost::make_shared<MatrixDouble>();
267  // Apply inertia
269  "U", mat_acceleration_ptr));
270  pip.push_back(new OpInertiaForce("U", mat_acceleration_ptr, get_rho));
271 
273  pip, mField, "U", {},
274  {boost::make_shared<TimeScaleVector<SPACE_DIM>>("-time_vector_file",
275  true)},
276  "BODY_FORCE", Sev::inform);
277 
279  };
280 
281  CHKERR apply_lhs(pipeline_mng->getOpDomainLhsPipeline());
282  CHKERR apply_rhs(pipeline_mng->getOpDomainRhsPipeline());
283 
284  auto integration_rule = [](int, int, int approx_order) {
285  return 2 * approx_order;
286  };
287  CHKERR pipeline_mng->setDomainRhsIntegrationRule(integration_rule);
288  CHKERR pipeline_mng->setDomainLhsIntegrationRule(integration_rule);
289 
290  auto get_bc_hook = [&]() {
292  mField, pipeline_mng->getDomainRhsFE(),
293  {boost::make_shared<TimeScale>()});
294  return hook;
295  };
296 
297  pipeline_mng->getDomainRhsFE()->preProcessHook = get_bc_hook();
298 
300 }
301 //! [Push operators to pipeline]
302 
303 /**
304  * @brief Monitor solution
305  *
306  * This functions is called by TS solver at the end of each step. It is used
307  * to output results to the hard drive.
308  */
309 struct Monitor : public FEMethod {
310  Monitor(SmartPetscObj<DM> dm, boost::shared_ptr<PostProcEle> post_proc)
311  : dM(dm), postProc(post_proc){};
314  constexpr int save_every_nth_step = 1;
315  if (ts_step % save_every_nth_step == 0) {
316  CHKERR DMoFEMLoopFiniteElements(dM, "dFE", postProc);
317  CHKERR postProc->writeFile(
318  "out_step_" + boost::lexical_cast<std::string>(ts_step) + ".h5m");
319  }
321  }
322 
323 private:
325  boost::shared_ptr<PostProcEle> postProc;
326 };
327 
328 //! [Solve]
331  auto *simple = mField.getInterface<Simple>();
332  auto *pipeline_mng = mField.getInterface<PipelineManager>();
333 
334  auto dm = simple->getDM();
336  ts = pipeline_mng->createTSIM2();
337 
338  // Setup postprocessing
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);
344 
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(
350  new OpCalculateVectorFieldValues<SPACE_DIM>("GEOMETRY", X_ptr));
351 
353 
354  post_proc_fe->getOpPtrVector().push_back(
355 
356  new OpPPMap(
357 
358  post_proc_fe->getPostProcMesh(), post_proc_fe->getMapGaussPts(),
359 
360  {},
361 
362  {{"U", u_ptr}, {"GEOMETRY", X_ptr}},
363 
364  {{"GRAD", common_ptr->matGradPtr},
365  {"FIRST_PIOLA", common_ptr->getMatFirstPiolaStress()}},
366 
367  {}
368 
369  )
370 
371  );
372 
373  // Add monitor to time solver
374  boost::shared_ptr<FEMethod> null_fe;
375  auto monitor_ptr = boost::make_shared<Monitor>(dm, post_proc_fe);
376  CHKERR DMMoFEMTSSetMonitor(dm, ts, simple->getDomainFEName(), null_fe,
377  null_fe, monitor_ptr);
378 
379  double ftime = 1;
380  // CHKERR TSSetMaxTime(ts, ftime);
381  CHKERR TSSetExactFinalTime(ts, TS_EXACTFINALTIME_MATCHSTEP);
382 
383  auto T = createDMVector(simple->getDM());
384  CHKERR DMoFEMMeshToLocalVector(simple->getDM(), T, INSERT_VALUES,
385  SCATTER_FORWARD);
386  auto TT = vectorDuplicate(T);
387  CHKERR TS2SetSolution(ts, T, TT);
388  CHKERR TSSetFromOptions(ts);
389 
390  CHKERR TSSolve(ts, NULL);
391  CHKERR TSGetTime(ts, &ftime);
392 
393  PetscInt steps, snesfails, rejects, nonlinits, linits;
394 #if PETSC_VERSION_GE(3, 8, 0)
395  CHKERR TSGetStepNumber(ts, &steps);
396 #else
397  CHKERR TSGetTimeStepNumber(ts, &steps);
398 #endif
399  CHKERR TSGetSNESFailures(ts, &snesfails);
400  CHKERR TSGetStepRejections(ts, &rejects);
401  CHKERR TSGetSNESIterations(ts, &nonlinits);
402  CHKERR TSGetKSPIterations(ts, &linits);
403  MOFEM_LOG_C("EXAMPLE", Sev::inform,
404  "steps %d (%d rejected, %d SNES fails), ftime %g, nonlinits "
405  "%d, linits %d\n",
406  steps, rejects, snesfails, ftime, nonlinits, linits);
407 
409 }
410 //! [Solve]
411 
412 //! [Postprocess results]
415  PetscBool test_flg = PETSC_FALSE;
416  CHKERR PetscOptionsGetBool(PETSC_NULL, "", "-test", &test_flg, PETSC_NULL);
417  if (test_flg) {
418  auto *simple = mField.getInterface<Simple>();
419  auto T = createDMVector(simple->getDM());
420  CHKERR DMoFEMMeshToLocalVector(simple->getDM(), T, INSERT_VALUES,
421  SCATTER_FORWARD);
422  double nrm2;
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)
427  SETERRQ(PETSC_COMM_WORLD, MOFEM_ATOM_TEST_INVALID,
428  "Regression test failed; wrong norm value.");
429  }
431 }
432 //! [Postprocess results]
433 
434 //! [Check]
438 }
439 //! [Check]
440 
441 static char help[] = "...\n\n";
442 
443 int main(int argc, char *argv[]) {
444 
445  // Initialisation of MoFEM/PETSc and MOAB data structures
446  const char param_file[] = "param_file.petsc";
447  MoFEM::Core::Initialize(&argc, &argv, param_file, help);
448 
449  // Add logging channel for example
450  auto core_log = logging::core::get();
451  core_log->add_sink(
453  LogManager::setLog("EXAMPLE");
454  MOFEM_LOG_TAG("EXAMPLE", "example");
455 
456  try {
457 
458  //! [Register MoFEM discrete manager in PETSc]
459  DMType dm_name = "DMMOFEM";
460  CHKERR DMRegister_MoFEM(dm_name);
461  //! [Register MoFEM discrete manager in PETSc
462 
463  //! [Create MoAB]
464  moab::Core mb_instance; ///< mesh database
465  moab::Interface &moab = mb_instance; ///< mesh database interface
466  //! [Create MoAB]
467 
468  //! [Create MoFEM]
469  MoFEM::Core core(moab); ///< finite element database
470  MoFEM::Interface &m_field = core; ///< finite element database interface
471  //! [Create MoFEM]
472 
473  //! [Example]
474  Example ex(m_field);
475  CHKERR ex.runProblem();
476  //! [Example]
477  }
478  CATCH_ERRORS;
479 
481 }
NOSPACE
@ NOSPACE
Definition: definitions.h:83
MoFEM::NaturalBC::Assembly::LinearForm
Definition: Natural.hpp:67
MoFEMFunctionReturnHot
#define MoFEMFunctionReturnHot(a)
Last executable line of each PETSc function used for error handling. Replaces return()
Definition: definitions.h:460
MoFEM::UnknownInterface::getInterface
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.
Definition: UnknownInterface.hpp:93
MoFEM::EntitiesFieldData::EntData
Data on single entity (This is passed as argument to DataOperator::doWork)
Definition: EntitiesFieldData.hpp:128
Example::checkResults
MoFEMErrorCode checkResults()
[Postprocess results]
Definition: dynamic_first_order_con_law.cpp:1194
EXECUTABLE_DIMENSION
#define EXECUTABLE_DIMENSION
Definition: plastic.cpp:13
Monitor::Monitor
Monitor(SmartPetscObj< DM > dm, boost::shared_ptr< PostProcEle > post_proc)
Definition: nonlinear_dynamic_elastic.cpp:310
Example::assembleSystem
MoFEMErrorCode assembleSystem()
[Push operators to pipeline]
Definition: dynamic_first_order_con_law.cpp:640
MoFEM::CoreTmp< 0 >
Core (interface) class.
Definition: Core.hpp:82
H1
@ H1
continuous field
Definition: definitions.h:85
FTensor::Tensor1
Definition: Tensor1_value.hpp:8
Example::Example
Example(MoFEM::Interface &m_field)
Definition: nonlinear_dynamic_elastic.cpp:52
MOFEM_LOG_CHANNEL
#define MOFEM_LOG_CHANNEL(channel)
Set and reset channel.
Definition: LogManager.hpp:284
MoFEM::FEMethod
structure for User Loop Methods on finite elements
Definition: LoopMethods.hpp:373
MoFEM::OpFluxRhsImpl
Definition: Natural.hpp:39
CHK_THROW_MESSAGE
#define CHK_THROW_MESSAGE(err, msg)
Check and throw MoFEM exception.
Definition: definitions.h:609
OpMass
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpMass< 1, SPACE_DIM > OpMass
Definition: nonlinear_dynamic_elastic.cpp:32
MoFEM::Exceptions::MoFEMErrorCode
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
Definition: Exceptions.hpp:56
MoFEM::OpCalculateVectorFieldValues
Get values at integration pts for tensor filed rank 1, i.e. vector field.
Definition: UserDataOperators.hpp:468
MoFEM::PETSC
@ PETSC
Definition: FormsIntegrators.hpp:105
MoFEM::PipelineManager
PipelineManager interface.
Definition: PipelineManager.hpp:24
MoFEM.hpp
MoFEM::DMoFEMMeshToLocalVector
PetscErrorCode DMoFEMMeshToLocalVector(DM dm, Vec l, InsertMode mode, ScatterMode scatter_mode)
set local (or ghosted) vector values on mesh for partition only
Definition: DMMoFEM.cpp:523
MoFEM::DisplacementCubitBcData
Definition of the displacement bc data structure.
Definition: BCData.hpp:76
MoFEM::Projection10NodeCoordsOnField
Projection of edge entities with one mid-node on hierarchical basis.
Definition: Projection10NodeCoordsOnField.hpp:24
MoFEM::CoreTmp< 0 >::Finalize
static MoFEMErrorCode Finalize()
Checks for options to be called at the conclusion of the program.
Definition: Core.cpp:112
HenckyOps
Definition: HenckyOps.hpp:11
OpInertiaForce
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpBaseTimesVector< 1, SPACE_DIM, 1 > OpInertiaForce
Definition: nonlinear_dynamic_elastic.cpp:34
MoFEM::LogManager::createSink
static boost::shared_ptr< SinkType > createSink(boost::shared_ptr< std::ostream > stream_ptr, std::string comm_filter)
Create a sink object.
Definition: LogManager.cpp:298
HenckyOps.hpp
Monitor::postProcess
MoFEMErrorCode postProcess()
function is run at the end of loop
Definition: nonlinear_dynamic_elastic.cpp:312
MoFEM::Simple
Simple interface for fast problem set-up.
Definition: Simple.hpp:27
SPACE_DIM
constexpr int SPACE_DIM
Definition: nonlinear_dynamic_elastic.cpp:23
order
constexpr int order
Definition: dg_projection.cpp:18
MoFEM::DeprecatedCoreInterface
Deprecated interface functions.
Definition: DeprecatedCoreInterface.hpp:16
MoFEM::Interface
DeprecatedCoreInterface Interface
Definition: Interface.hpp:2010
MoFEM::OpCalculateVectorFieldValuesFromPetscVecImpl
Approximate field values for given petsc vector.
Definition: UserDataOperators.hpp:597
Example::readMesh
MoFEMErrorCode readMesh()
[Run problem]
Definition: dynamic_first_order_con_law.cpp:462
OpInertiaForce
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpBaseTimesVector< 1, SPACE_DIM, 1 > OpInertiaForce
Definition: dynamic_first_order_con_law.cpp:62
MoFEM::PostProcBrokenMeshInMoab
Definition: PostProcBrokenMeshInMoabBase.hpp:677
help
static char help[]
[Check]
Definition: nonlinear_dynamic_elastic.cpp:441
save_every_nth_step
int save_every_nth_step
Definition: photon_diffusion.cpp:67
CHKERR
#define CHKERR
Inline error check.
Definition: definitions.h:548
MoFEM::createDMVector
auto createDMVector(DM dm)
Get smart vector from DM.
Definition: DMMoFEM.hpp:1099
MoFEM::EssentialPreProc< DisplacementCubitBcData >
Specialization for DisplacementCubitBcData.
Definition: EssentialDisplacementCubitBcData.hpp:91
MoFEM::CoreInterface::get_moab
virtual moab::Interface & get_moab()=0
MoFEM
implementation of Data Operators for Forces and Sources
Definition: Common.hpp:10
MoFEM::BcManager
Simple interface for fast problem set-up.
Definition: BcManager.hpp:25
OpMass
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpMass< 1, SPACE_DIM > OpMass
[Only used with Hooke equation (linear material model)]
Definition: seepage.cpp:57
MOFEM_LOG_C
#define MOFEM_LOG_C(channel, severity, format,...)
Definition: LogManager.hpp:311
rho
constexpr double rho
Definition: nonlinear_dynamic_elastic.cpp:42
simple
void simple(double P1[], double P2[], double P3[], double c[], const int N)
Definition: acoustic.cpp:69
Example
[Example]
Definition: plastic.cpp:216
double
convert.type
type
Definition: convert.py:64
MoFEM::FormsIntegrators::Assembly
Assembly methods.
Definition: FormsIntegrators.hpp:317
OpPPMap
OpPostProcMapInMoab< SPACE_DIM, SPACE_DIM > OpPPMap
Definition: photon_diffusion.cpp:29
Example::solveSystem
MoFEMErrorCode solveSystem()
[Solve]
Definition: dynamic_first_order_con_law.cpp:884
main
int main(int argc, char *argv[])
Definition: nonlinear_dynamic_elastic.cpp:443
MoFEM::LogManager::getStrmWorld
static boost::shared_ptr< std::ostream > getStrmWorld()
Get the strm world object.
Definition: LogManager.cpp:344
MoFEM::DMRegister_MoFEM
PetscErrorCode DMRegister_MoFEM(const char sname[])
Register MoFEM problem.
Definition: DMMoFEM.cpp:43
MoFEM::GAUSS
@ GAUSS
Definition: FormsIntegrators.hpp:136
MatrixFunction.hpp
MoFEM::FaceElementForcesAndSourcesCore
Face finite element.
Definition: FaceElementForcesAndSourcesCore.hpp:23
MoFEM::LogManager::SeverityLevel
SeverityLevel
Severity levels.
Definition: LogManager.hpp:33
MOFEM_LOG_TAG
#define MOFEM_LOG_TAG(channel, tag)
Tag channel.
Definition: LogManager.hpp:339
MoFEM::AddFluxToRhsPipelineImpl
Definition: Natural.hpp:46
MoFEM::VolumeElementForcesAndSourcesCore
Volume finite element base.
Definition: VolumeElementForcesAndSourcesCore.hpp:26
i
FTensor::Index< 'i', SPACE_DIM > i
Definition: hcurl_divergence_operator_2d.cpp:27
BiLinearForm
omega
constexpr double omega
Definition: nonlinear_dynamic_elastic.cpp:43
FTensor::Index< 'i', SPACE_DIM >
AINSWORTH_BERNSTEIN_BEZIER_BASE
@ AINSWORTH_BERNSTEIN_BEZIER_BASE
Definition: definitions.h:64
MoFEM::AddHOOps
Add operators pushing bases from local to physical configuration.
Definition: HODataOperators.hpp:417
integration_rule
auto integration_rule
Definition: free_surface.cpp:187
ElementsAndOps
Definition: child_and_parent.cpp:18
Range
DomainEleOp
MoFEM::CoreTmp< 0 >::Initialize
static MoFEMErrorCode Initialize(int *argc, char ***args, const char file[], const char help[])
Initializes the MoFEM database PETSc, MOAB and MPI.
Definition: Core.cpp:72
MOFEM_TAG_AND_LOG
#define MOFEM_TAG_AND_LOG(channel, severity, tag)
Tag and log in channel.
Definition: LogManager.hpp:362
MOFEM_LOG
#define MOFEM_LOG(channel, severity)
Log.
Definition: LogManager.hpp:308
MoFEM::NaturalBC::Assembly
Assembly methods.
Definition: Natural.hpp:65
MoFEM::vectorDuplicate
SmartPetscObj< Vec > vectorDuplicate(Vec vec)
Create duplicate vector of smart vector.
Definition: PetscSmartObj.hpp:221
CATCH_ERRORS
#define CATCH_ERRORS
Catch errors.
Definition: definitions.h:385
MoFEM::Core
CoreTmp< 0 > Core
Definition: Core.hpp:1148
MoFEM::TSMethod::ts_aa
PetscReal ts_aa
shift for U_tt shift for U_tt
Definition: LoopMethods.hpp:165
Example::setupProblem
MoFEMErrorCode setupProblem()
[Run problem]
Definition: plastic.cpp:275
poisson_ratio
constexpr double poisson_ratio
Definition: nonlinear_dynamic_elastic.cpp:45
UserDataOperator
ForcesAndSourcesCore::UserDataOperator UserDataOperator
Definition: HookeElement.hpp:75
EntData
EntitiesFieldData::EntData EntData
Definition: nonlinear_dynamic_elastic.cpp:26
Example::boundaryCondition
MoFEMErrorCode boundaryCondition()
[Set up problem]
Definition: dynamic_first_order_con_law.cpp:535
Monitor
[Push operators to pipeline]
Definition: dynamic_first_order_con_law.cpp:774
approx_order
int approx_order
Definition: test_broken_space.cpp:54
MoFEM::DMMoFEMTSSetMonitor
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.
Definition: DMMoFEM.cpp:1056
AINSWORTH_LEGENDRE_BASE
@ AINSWORTH_LEGENDRE_BASE
Ainsworth Cole (Legendre) approx. base .
Definition: definitions.h:60
MOFEM_DATA_INCONSISTENCY
@ MOFEM_DATA_INCONSISTENCY
Definition: definitions.h:31
MoFEM::MeshsetsManager
Interface for managing meshsets containing materials and boundary conditions.
Definition: MeshsetsManager.hpp:104
MoFEM::BlockData
Definition: MeshsetsManager.cpp:766
Example::runProblem
MoFEMErrorCode runProblem()
[Run problem]
Definition: plastic.cpp:256
m
FTensor::Index< 'm', 3 > m
Definition: shallow_wave.cpp:80
MOFEM_ATOM_TEST_INVALID
@ MOFEM_ATOM_TEST_INVALID
Definition: definitions.h:40
DomainEle
ElementsAndOps< SPACE_DIM >::DomainEle DomainEle
Definition: child_and_parent.cpp:34
MoFEM::MeshsetsManager::getCubitMeshsetPtr
MoFEMErrorCode getCubitMeshsetPtr(const int ms_id, const CubitBCType cubit_bc_type, const CubitMeshSets **cubit_meshset_ptr) const
get cubit meshset
Definition: MeshsetsManager.cpp:589
MoFEM::LogManager::setLog
static LoggerType & setLog(const std::string channel)
Set ans resset chanel logger.
Definition: LogManager.cpp:389
MoFEM::SmartPetscObj< DM >
Example::outputResults
MoFEMErrorCode outputResults()
[Solve]
Definition: dynamic_first_order_con_law.cpp:1172
MoFEM::DMoFEMLoopFiniteElements
PetscErrorCode DMoFEMLoopFiniteElements(DM dm, const char fe_name[], MoFEM::FEMethod *method, CacheTupleWeakPtr cache_ptr=CacheTupleSharedPtr())
Executes FEMethod for finite elements in DM.
Definition: DMMoFEM.cpp:586
convert.int
int
Definition: convert.py:64
MoFEM::PetscOptionsGetInt
PetscErrorCode PetscOptionsGetInt(PetscOptions *, const char pre[], const char name[], PetscInt *ivalue, PetscBool *set)
Definition: DeprecatedPetsc.hpp:142
MoFEMFunctionReturn
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
Definition: definitions.h:429
MoFEMFunctionBegin
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
Definition: definitions.h:359
MoFEM::PetscOptionsGetBool
PetscErrorCode PetscOptionsGetBool(PetscOptions *, const char pre[], const char name[], PetscBool *bval, PetscBool *set)
Definition: DeprecatedPetsc.hpp:182
MoFEM::OpPostProcMapInMoab
Post post-proc data at points from hash maps.
Definition: PostProcBrokenMeshInMoabBase.hpp:709
young_modulus
constexpr double young_modulus
Definition: nonlinear_dynamic_elastic.cpp:44