v0.14.0
HMHNeohookean.cpp
Go to the documentation of this file.
1 /**
2  * @file HMHNeohookean.cpp
3  * @brief Implementation of NeoHookean material
4  * @date 2024-08-31
5  *
6  * @copyright Copyright (c) 2024
7  *
8  */
9 
10 namespace EshelbianPlasticity {
11 
12 #define NEOHOOKEAN_OFF_INVERSE
13 // #define NEOHOOKEAN_SCALING
15 
16  static constexpr int numberOfActiveVariables = 0;
17  static constexpr int numberOfDependentVariables = 0;
18 
19  HMHNeohookean(MoFEM::Interface &m_field, const double c10, const double K)
21  mField(m_field), c10_default(c10), K_default(K) {
22 
23  CHK_THROW_MESSAGE(getOptions(), "get options failed");
25  "extract block data failed");
26 
27 #ifdef NEOHOOKEAN_SCALING
28  if (blockData.size()) {
29  double ave_K = 0;
30  for (auto b : blockData) {
31  ave_K += b.K;
32  }
33  eqScaling = ave_K / blockData.size();
34  }
35 #endif
36 
37  MOFEM_LOG("EP", Sev::inform) << "Neo-Hookean scaling = " << eqScaling;
38 
41  "Stretch selector is not equal to LOG");
42  } else {
43  if (EshelbianCore::exponentBase != exp(1)) {
45  "Exponent base is not equal to exp(1)");
46  }
47  }
48  }
49 
51  for (auto &b : blockData) {
52  if (b.blockEnts.find(ent) != b.blockEnts.end()) {
53  return std::make_pair(b.c10, b.K);
54  }
55  }
56  if (blockData.size() != 0)
58  "Block not found for entity handle. If you mat set "
59  "block, set it to all elements");
60  return std::make_pair(c10_default, K_default);
61  }
62 
63  struct OpGetScale : public VolUserDataOperator {
64  OpGetScale(boost::shared_ptr<double> scale_ptr,
65  boost::shared_ptr<PhysicalEquations> physics_ptr)
67  scalePtr(scale_ptr), physicsPtr(physics_ptr) {}
68 
69  MoFEMErrorCode doWork(int side, EntityType type,
72  auto neohookean_ptr =
73  boost::dynamic_pointer_cast<HMHNeohookean>(physicsPtr);
74  *(scalePtr) = neohookean_ptr->eqScaling;
76  }
77 
78  private:
79  boost::shared_ptr<double> scalePtr;
80  boost::shared_ptr<PhysicalEquations> physicsPtr;
81  };
82 
84  returnOpSetScale(boost::shared_ptr<double> scale_ptr,
85  boost::shared_ptr<PhysicalEquations> physics_ptr) {
86 
87  return new OpGetScale(scale_ptr, physics_ptr);
88  };
89 
90  struct OpJacobian : public EshelbianPlasticity::OpJacobian {
91  using EshelbianPlasticity::OpJacobian::OpJacobian;
92  MoFEMErrorCode evaluateRhs(EntData &data) { return 0; }
93  MoFEMErrorCode evaluateLhs(EntData &data) { return 0; }
94  };
95 
96  virtual EshelbianPlasticity::OpJacobian *
97  returnOpJacobian(const int tag, const bool eval_rhs, const bool eval_lhs,
98  boost::shared_ptr<DataAtIntegrationPts> data_ptr,
99  boost::shared_ptr<PhysicalEquations> physics_ptr) {
100  return (new OpJacobian(tag, eval_rhs, eval_lhs, data_ptr, physics_ptr));
101  }
102 
105  CHKERR PetscOptionsBegin(PETSC_COMM_WORLD, "neo_hookean_", "", "none");
106 
107  c10_default = 1;
108  CHKERR PetscOptionsScalar("-c10", "C10", "", c10_default, &c10_default,
109  PETSC_NULL);
110  K_default = 1;
111  CHKERR PetscOptionsScalar("-K", "Bulk modulus K", "", K_default, &K_default,
112  PETSC_NULL);
113 
114  alphaGradU = 0;
115  CHKERR PetscOptionsScalar("-viscosity_alpha_grad_u", "viscosity", "",
116  alphaGradU, &alphaGradU, PETSC_NULL);
117 
118  ierr = PetscOptionsEnd();
119  CHKERRG(ierr);
120 
121  MOFEM_LOG_CHANNEL("WORLD");
122  MOFEM_TAG_AND_LOG("WORLD", Sev::inform, "MatBlock Neo-Hookean (default)")
123  << "c10 = " << c10_default << " K = " << K_default
124  << " grad alpha u = " << alphaGradU;
126  }
127 
129  return extractBlockData(
130 
131  mField.getInterface<MeshsetsManager>()->getCubitMeshsetPtr(std::regex(
132 
133  (boost::format("%s(.*)") % "MAT_NEOHOOKEAN").str()
134 
135  )),
136 
137  sev);
138  }
139 
141  extractBlockData(std::vector<const CubitMeshSets *> meshset_vec_ptr,
142  Sev sev) {
144 
145  for (auto m : meshset_vec_ptr) {
146  MOFEM_LOG("EP", sev) << *m;
147  std::vector<double> block_data;
148  CHKERR m->getAttributes(block_data);
149  if (block_data.size() != 2) {
150  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
151  "Expected that block has two attribute");
152  }
153  auto get_block_ents = [&]() {
154  Range ents;
155  CHKERR mField.get_moab().get_entities_by_handle(m->meshset, ents, true);
156  return ents;
157  };
158 
159  double c10 = block_data[0];
160  double K = block_data[1];
161 
162  blockData.push_back({c10, K, get_block_ents()});
163 
164  MOFEM_LOG("EP", sev) << "MatBlock Neo-Hookean c10 = "
165  << blockData.back().c10
166  << " K = " << blockData.back().K << " nb ents. = "
167  << blockData.back().blockEnts.size();
168  }
170  }
171 
172  MoFEMErrorCode recordTape(const int tape, DTensor2Ptr *t_h_ptr) {
175  }
176 
178 
179  OpSpatialPhysical(const std::string &field_name,
180  boost::shared_ptr<DataAtIntegrationPts> data_ptr,
181  const double alpha_u);
182 
184 
185  private:
186  const double alphaU;
187  };
188 
189  virtual VolUserDataOperator *
191  boost::shared_ptr<DataAtIntegrationPts> data_ptr,
192  const double alpha_u) {
193  return new OpSpatialPhysical(field_name, data_ptr, alpha_u);
194  }
195 
197  OpSpatialPhysical_du_du(std::string row_field, std::string col_field,
198  boost::shared_ptr<DataAtIntegrationPts> data_ptr,
199  const double alpha);
200  MoFEMErrorCode integrate(EntData &row_data, EntData &col_data);
201 
202  private:
203  const double alphaU;
204  };
205 
207  std::string row_field, std::string col_field,
208  boost::shared_ptr<DataAtIntegrationPts> data_ptr, const double alpha) {
209  return new OpSpatialPhysical_du_du(row_field, col_field, data_ptr, alpha);
210  }
211 
212 private:
214 
215  double c10_default;
216  double K_default;
217  double alphaGradU;
218  struct BlockData {
219  double c10;
220  double K;
222  };
223  std::vector<BlockData> blockData;
224 
225  double eqScaling = 1.;
226 
227 };
228 
230  const std::string &field_name,
231  boost::shared_ptr<DataAtIntegrationPts> data_ptr, const double alpha_u)
232  : OpAssembleVolume(field_name, data_ptr, OPROW), alphaU(alpha_u) {}
233 
236 
237  auto neohookean_ptr =
238  boost::dynamic_pointer_cast<HMHNeohookean>(dataAtPts->physicsPtr);
239  if (!neohookean_ptr) {
240  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
241  "Pointer to HMHNeohookean is null");
242  }
243  auto [def_c10, def_K] =
244  neohookean_ptr->getMaterialParameters(getFEEntityHandle());
245 
246  double c10 = def_c10 / neohookean_ptr->eqScaling;
247  double alpha_u = alphaU / neohookean_ptr->eqScaling;
248  double K = def_K / neohookean_ptr->eqScaling;
249 
250  double alpha_grad_u = neohookean_ptr->alphaGradU / neohookean_ptr->eqScaling;
251 
253  auto t_L = symm_L_tensor();
254 
255  constexpr auto t_kd_sym = FTensor::Kronecker_Delta_symmetric<int>();
256  constexpr auto t_kd = FTensor::Kronecker_Delta<int>();
257 
258  int nb_dofs = data.getIndices().size();
259  int nb_integration_pts = data.getN().size1();
260  auto v = getVolume();
261  auto t_w = getFTensor0IntegrationWeight();
262  auto t_approx_P_adjoint_log_du =
263  getFTensor1FromMat<size_symm>(dataAtPts->adjointPdUAtPts);
264  auto t_u = getFTensor2SymmetricFromMat<3>(dataAtPts->stretchTensorAtPts);
265  auto t_grad_h1 = getFTensor2FromMat<3, 3>(dataAtPts->wGradH1AtPts);
266  auto t_dot_log_u =
267  getFTensor2SymmetricFromMat<3>(dataAtPts->logStretchDotTensorAtPts);
268  auto t_diff_u =
269  getFTensor4DdgFromMat<3, 3, 1>(dataAtPts->diffStretchTensorAtPts);
270  auto t_log_u =
271  getFTensor2SymmetricFromMat<3>(dataAtPts->logStretchTensorAtPts);
272  auto t_grad_log_u =
273  getFTensor2FromMat<6, 3>(dataAtPts->gradLogStretchDotTensorAtPts);
274  auto t_log_u2_h1 =
275  getFTensor2SymmetricFromMat<3>(dataAtPts->logStretch2H1AtPts);
276 
277  auto t_diff = diff_tensor();
278 
285 
286  auto get_ftensor2 = [](auto &v) {
288  &v[0], &v[1], &v[2], &v[3], &v[4], &v[5]);
289  };
290 
291  int nb_base_functions = data.getN().size2();
292  auto t_row_base_fun = data.getFTensor0N();
293  auto t_grad_base_fun = data.getFTensor1DiffN<3>();
294 
295  auto no_h1 = [&]() {
297 
298  for (int gg = 0; gg != nb_integration_pts; ++gg) {
299  double a = v * t_w;
300  ++t_w;
301 
303  t_Ldiff_u(i, j, L) = t_diff_u(i, j, k, l) * t_L(k, l, L);
304  ++t_diff_u;
305 
307  t_Sigma_u(i, j) = 2.0 * c10 * t_u(i, j);
308  const double tr = t_log_u(i, i);
309  const double J = EshelbianCore::f(tr);
310  const double Sigma_J = -2.0 * c10 + K * (J * J - J);
311 
313  t_viscous_P(i, j) =
314  alpha_u * (t_dot_log_u(i, j) -
315  t_dot_log_u(k, l) * t_kd_sym(k, l) * t_kd_sym(i, j));
316 
318  t_residual(L) = t_approx_P_adjoint_log_du(L);
319  t_residual(L) -= t_Ldiff_u(i, j, L) * t_Sigma_u(i, j);
320  t_residual(L) -= (t_L(i, j, L) * t_kd(i, j)) * Sigma_J;
321  t_residual(L) -= t_L(i, j, L) * t_viscous_P(i, j);
322  t_residual(L) *= a;
323 
325  t_grad_residual(L, i) = alpha_grad_u * t_grad_log_u(L, i);
326  t_grad_residual(L, i) *= a;
327 
328  ++t_approx_P_adjoint_log_du;
329  ++t_u;
330  ++t_log_u;
331  ++t_dot_log_u;
332  ++t_grad_log_u;
333 
334  auto t_nf = getFTensor1FromPtr<size_symm>(&*nF.data().begin());
335  int bb = 0;
336  for (; bb != nb_dofs / size_symm; ++bb) {
337  t_nf(L) -= t_row_base_fun * t_residual(L);
338  t_nf(L) += t_grad_base_fun(i) * t_grad_residual(L, i);
339  ++t_nf;
340  ++t_row_base_fun;
341  ++t_grad_base_fun;
342  }
343  for (; bb != nb_base_functions; ++bb) {
344  ++t_row_base_fun;
345  ++t_grad_base_fun;
346  }
347  }
348 
350  };
351 
352  auto large = [&]() {
354 
355  for (int gg = 0; gg != nb_integration_pts; ++gg) {
356  double a = v * t_w;
357  ++t_w;
358 
361  t_h1(i, j) = t_grad_h1(i, j) + t_kd(i, j);
362  t_Ldiff_u(i, j, L) = (t_diff_u(i, m, k, l) * t_h1(m, j)) * t_L(k, l, L);
363  ++t_diff_u;
364  ++t_grad_h1;
365 
367  const double tr_h1 = t_log_u2_h1(i, j) * t_kd_sym(i, j) / 2;
368  const double tr_u = t_log_u(i, j) * t_kd_sym(i, j);
369  const double tr = tr_h1 + tr_u;
370  const double J = EshelbianCore::f(tr);
371 
373  t_total_u(i, j) = t_u(i, m) * t_h1(m, j);
374 #ifndef NEOHOOKEAN_OFF_INVERSE
376  invertTensor3by3(t_total_u, J, t_inv_total_u);
377 #endif // NEOHOOKEAN_OFF_INVERSE
378 
379 #ifndef NEOHOOKEAN_OFF_INVERSE
380  if (tr > 0) {
381  t_Sigma_u(i, j) =
382  2.0 * c10 * t_total_u(i, m) *
383  (t_kd_sym(m, j) - t_inv_total_u(m, k) * t_inv_total_u(k, j));
384  } else {
385  t_Sigma_u(i, j) = -2.0 * c10 * t_inv_total_u(i, m) *
386  (t_kd_sym(m, j) - t_total_u(m, k) * t_total_u(k, j));
387  }
388 #else
389  t_Sigma_u(i, j) = 2.0 * c10 * t_total_u(i, j);
390 #endif // NEOHOOKEAN_OFF_INVERSE
391 
392 #ifndef NEOHOOKEAN_OFF_INVERSE
393  const double Sigma_J = K * (J * J - J);
394 #else
395  const double Sigma_J = -2.0 * c10 + K * (J * J - J);
396 #endif // NEOHOOKEAN_OFF_INVERSE
397 
399  t_viscous_P(i, j) =
400  alpha_u * (t_dot_log_u(i, j) -
401  t_dot_log_u(k, l) * t_kd_sym(k, l) * t_kd_sym(i, j));
402 
404  t_residual(L) = t_approx_P_adjoint_log_du(L);
405  t_residual(L) -= t_Ldiff_u(i, j, L) * t_Sigma_u(i, j);
406  t_residual(L) -= (t_L(i, j, L) * t_kd(i, j)) * Sigma_J;
407  t_residual(L) -= t_L(i, j, L) * t_viscous_P(i, j);
408  t_residual(L) *= a;
409 
411  t_grad_residual(L, i) = alpha_grad_u * t_grad_log_u(L, i);
412  t_grad_residual(L, i) *= a;
413 
414  ++t_approx_P_adjoint_log_du;
415  ++t_u;
416  ++t_log_u;
417  ++t_log_u2_h1;
418  ++t_dot_log_u;
419  ++t_grad_log_u;
420 
421  auto t_nf = getFTensor1FromPtr<size_symm>(&*nF.data().begin());
422  int bb = 0;
423  for (; bb != nb_dofs / size_symm; ++bb) {
424  t_nf(L) -= t_row_base_fun * t_residual(L);
425  t_nf(L) += t_grad_base_fun(i) * t_grad_residual(L, i);
426  ++t_nf;
427  ++t_row_base_fun;
428  ++t_grad_base_fun;
429  }
430  for (; bb != nb_base_functions; ++bb) {
431  ++t_row_base_fun;
432  ++t_grad_base_fun;
433  }
434  }
435 
437  };
438 
440  case NO_H1_CONFIGURATION:
441  CHKERR no_h1();
442  break;
443  case LARGE_ROT:
444  case MODERATE_ROT:
445  CHKERR large();
446  break;
447  default:
448  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
449  "gradApproximator not handled");
450  };
451 
453 }
454 
456  std::string row_field, std::string col_field,
457  boost::shared_ptr<DataAtIntegrationPts> data_ptr, const double alpha)
458  : OpAssembleVolume(row_field, col_field, data_ptr, OPROWCOL, false),
459  alphaU(alpha) {
460  sYmm = false;
461 }
462 
465  EntData &col_data) {
467 
468  auto neohookean_ptr =
469  boost::dynamic_pointer_cast<HMHNeohookean>(dataAtPts->physicsPtr);
470  if (!neohookean_ptr) {
471  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
472  "Pointer to HMHNeohookean is null");
473  }
474  auto [def_c10, def_K] =
475  neohookean_ptr->getMaterialParameters(getFEEntityHandle());
476 
477  double c10 = def_c10 / neohookean_ptr->eqScaling;
478  double alpha_u = alphaU / neohookean_ptr->eqScaling;
479  double lambda = def_K / neohookean_ptr->eqScaling;
480 
481  double alpha_grad_u = neohookean_ptr->alphaGradU / neohookean_ptr->eqScaling;
482 
485 
486  constexpr auto t_kd_sym = FTensor::Kronecker_Delta_symmetric<int>();
487  constexpr auto t_kd = FTensor::Kronecker_Delta<int>();
488 
489  auto t_L = symm_L_tensor();
490  auto t_diff = diff_tensor();
491 
492  int nb_integration_pts = row_data.getN().size1();
493  int row_nb_dofs = row_data.getIndices().size();
494  int col_nb_dofs = col_data.getIndices().size();
495 
496  auto get_ftensor2 = [](MatrixDouble &m, const int r, const int c) {
498  size_symm>(
499 
500  &m(r + 0, c + 0), &m(r + 0, c + 1), &m(r + 0, c + 2), &m(r + 0, c + 3),
501  &m(r + 0, c + 4), &m(r + 0, c + 5),
502 
503  &m(r + 1, c + 0), &m(r + 1, c + 1), &m(r + 1, c + 2), &m(r + 1, c + 3),
504  &m(r + 1, c + 4), &m(r + 1, c + 5),
505 
506  &m(r + 2, c + 0), &m(r + 2, c + 1), &m(r + 2, c + 2), &m(r + 2, c + 3),
507  &m(r + 2, c + 4), &m(r + 2, c + 5),
508 
509  &m(r + 3, c + 0), &m(r + 3, c + 1), &m(r + 3, c + 2), &m(r + 3, c + 3),
510  &m(r + 3, c + 4), &m(r + 3, c + 5),
511 
512  &m(r + 4, c + 0), &m(r + 4, c + 1), &m(r + 4, c + 2), &m(r + 4, c + 3),
513  &m(r + 4, c + 4), &m(r + 4, c + 5),
514 
515  &m(r + 5, c + 0), &m(r + 5, c + 1), &m(r + 5, c + 2), &m(r + 5, c + 3),
516  &m(r + 5, c + 4), &m(r + 5, c + 5)
517 
518  );
519  };
520 
527 
528  auto v = getVolume();
529  auto ts_a = getTSa();
530  auto t_w = getFTensor0IntegrationWeight();
531 
532  int row_nb_base_functions = row_data.getN().size2();
533  auto t_row_base_fun = row_data.getFTensor0N();
534  auto t_row_grad_fun = row_data.getFTensor1DiffN<3>();
535 
536  auto t_grad_h1 = getFTensor2FromMat<3, 3>(dataAtPts->wGradH1AtPts);
537  auto t_diff_u =
538  getFTensor4DdgFromMat<3, 3, 1>(dataAtPts->diffStretchTensorAtPts);
539  auto t_log_u =
540  getFTensor2SymmetricFromMat<3>(dataAtPts->logStretchTensorAtPts);
541  auto t_log_u2_h1 =
542  getFTensor2SymmetricFromMat<3>(dataAtPts->logStretch2H1AtPts);
543  auto t_u = getFTensor2SymmetricFromMat<3>(dataAtPts->stretchTensorAtPts);
544  auto t_approx_P_adjoint_dstretch =
545  getFTensor2FromMat<3, 3>(dataAtPts->adjointPdstretchAtPts);
546  auto t_eigen_vals = getFTensor1FromMat<3>(dataAtPts->eigenVals);
547  auto t_eigen_vecs = getFTensor2FromMat<3, 3>(dataAtPts->eigenVecs);
548  auto &nbUniq = dataAtPts->nbUniq;
549 
550  auto t_P = getFTensor2FromMat<3, 3>(dataAtPts->PAtPts);
551  auto r_P_du = getFTensor4FromMat<3, 3, 3, 3>(dataAtPts->P_du);
552 
553  auto no_h1 = [&]() {
555 
556  for (int gg = 0; gg != nb_integration_pts; ++gg) {
557  double a = v * t_w;
558  ++t_w;
559 
561  t_Ldiff_u(i, j, L) = t_diff_u(i, j, k, l) * t_L(k, l, L);
562  ++t_diff_u;
563 
564  const double tr = t_log_u(i, i);
565  const double det_u = EshelbianCore::f(tr);
566  ++t_log_u;
567 
569  Sigma_J_dtr(L) =
570  (lambda * (2 * det_u * det_u - det_u)) * (t_kd(i, j) * t_L(i, j, L));
571 
572 
574  t_dP(L, J) = (-2.0 * c10) * (t_Ldiff_u(i, j, L) * t_Ldiff_u(i, j, J));
575  t_dP(L, J) -= (t_L(i, j, L) * t_kd(i, j)) * Sigma_J_dtr(J);
576  t_dP(L, J) -= (alpha_u * ts_a) *
577  (t_L(i, j, L) * (t_diff(i, j, k, l) * t_L(k, l, J) -
578  (t_diff(m, n, k, l) * t_kd_sym(m, n)) *
579  t_kd_sym(i, j) * t_L(k, l, J)));
580 
582  t_Sigma_u(i, j) = 2.0 * c10 * t_u(i, j);
583  ++t_u;
584 
585  if constexpr (1) {
587  t_deltaP(i, j) = t_approx_P_adjoint_dstretch(i, j) - t_Sigma_u(i, j);
588  auto t_diff2_uP = EigenMatrix::getDiffDiffMat(
589  t_eigen_vals, t_eigen_vecs, EshelbianCore::f, EshelbianCore::d_f,
590  EshelbianCore::dd_f, t_deltaP, nbUniq[gg]);
591  t_dP(L, J) += t_L(i, j, L) * (t_diff2_uP(i, j, k, l) * t_L(k, l, J));
592  }
593  ++t_approx_P_adjoint_dstretch;
594  ++t_eigen_vals;
595  ++t_eigen_vecs;
596 
597  int rr = 0;
598  for (; rr != row_nb_dofs / size_symm; ++rr) {
599  auto t_col_base_fun = col_data.getFTensor0N(gg, 0);
600  auto t_col_grad_fun = col_data.getFTensor1DiffN<3>(gg, 0);
601 
602  auto t_m = get_ftensor2(K, 6 * rr, 0);
603  for (int cc = 0; cc != col_nb_dofs / size_symm; ++cc) {
604  double b = a * t_row_base_fun * t_col_base_fun;
605  double c = (a * alpha_grad_u * ts_a) *
606  (t_row_grad_fun(i) * t_col_grad_fun(i));
607  t_m(L, J) -= b * t_dP(L, J);
608  t_m(L, J) += c * t_kd_sym(L, J);
609 
610  ++t_m;
611  ++t_col_base_fun;
612  ++t_col_grad_fun;
613  }
614  ++t_row_base_fun;
615  ++t_row_grad_fun;
616  }
617 
618  for (; rr != row_nb_base_functions; ++rr) {
619  ++t_row_base_fun;
620  ++t_row_grad_fun;
621  }
622 
623  ++t_P;
624  ++r_P_du;
625  }
627  };
628 
629  auto large = [&]() {
631 
632  for (int gg = 0; gg != nb_integration_pts; ++gg) {
633  double a = v * t_w;
634  ++t_w;
635 
638 
640  case NO_H1_CONFIGURATION:
641  t_h1(i, j) = t_kd(i, j);
642  t_Ldiff_u(i, j, L) = t_diff_u(i, j, k, l) * t_L(k, l, L);
643  break;
644  case LARGE_ROT:
645  case MODERATE_ROT:
646  t_h1(i, j) = t_grad_h1(i, j) + t_kd(i, j);
647  t_Ldiff_u(i, j, L) = (t_diff_u(i, m, k, l) * t_h1(m, j)) * t_L(k, l, L);
648  break;
649  default:
650  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
651  "gradApproximator not handled");
652  };
653  ++t_diff_u;
654  ++t_grad_h1;
655 
656  const double tr_h1 = t_log_u2_h1(i, j) * t_kd_sym(i, j) / 2;
657  const double tr_u = t_log_u(i, j) * t_kd_sym(i, j);
658  const double tr = tr_h1 + tr_u;
659  const double det_u = EshelbianCore::f(tr);
660  ++t_log_u;
661  ++t_log_u2_h1;
662 
664  Sigma_J_dtr(L) =
665  (lambda * (2 * det_u * det_u - det_u)) * (t_kd(i, j) * t_L(i, j, L));
666 
668  t_total_u(i, j) = t_u(i, m) * t_h1(m, j);
669 #ifndef NEOHOOKEAN_OFF_INVERSE
671  invertTensor3by3(t_total_u, det_u, t_inv_total_u);
672 #endif // NEOHOOKEAN_OFF_INVERSE
673  ++t_u;
674 
676 #ifndef NEOHOOKEAN_OFF_INVERSE
678  t_Sigma_u_du(i, j, J) = t_Ldiff_u(i, j, J) + t_inv_total_u(i, k) *
679  t_Ldiff_u(k, l, J) *
680  t_inv_total_u(l, j);
681  t_dP(L, J) = (-2.0 * c10) * (t_Ldiff_u(i, j, L) * t_Sigma_u_du(i, j, J));
682 #else
683  t_dP(L, J) = (-2.0 * c10) * (t_Ldiff_u(i, j, L) * t_Ldiff_u(i, j, J));
684 #endif // NEOHOOKEAN_OFF_INVERSE
685 
686  t_dP(L, J) -= (t_L(i, j, L) * t_kd(i, j)) * Sigma_J_dtr(J);
687  t_dP(L, J) -= (alpha_u * ts_a) *
688  (t_L(i, j, L) * (t_diff(i, j, k, l) * t_L(k, l, J) -
689  (t_diff(m, n, k, l) * t_kd_sym(m, n)) *
690  t_kd_sym(i, j) * t_L(k, l, J)));
691 
693 #ifndef NEOHOOKEAN_OFF_INVERSE
694  if (tr > 0) {
695  t_Sigma_u(i, j) =
696  2.0 * c10 * t_total_u(i, m) *
697  (t_kd_sym(m, j) - t_inv_total_u(m, k) * t_inv_total_u(k, j));
698  } else {
699  t_Sigma_u(i, j) = -2.0 * c10 * t_inv_total_u(i, m) *
700  (t_kd_sym(m, j) - t_total_u(m, k) * t_total_u(k, j));
701  }
702 #else
703  t_Sigma_u(i, j) = 2.0 * c10 * t_total_u(i, j);
704 #endif // NEOHOOKEAN_OFF_INVERSE
705 
708  case NO_H1_CONFIGURATION:
709  case LARGE_ROT:
710  t_deltaP(i, j) =
711  t_approx_P_adjoint_dstretch(i, j) - t_h1(j, n) * t_Sigma_u(i, n);
712  break;
713  case MODERATE_ROT:
714  t_deltaP(i, j) = -t_h1(j, n) * t_Sigma_u(i, n);
715  break;
716  default:
717  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
718  "gradApproximator not handled");
719  };
720  ++t_approx_P_adjoint_dstretch;
721 
722  if constexpr (1) {
724  t_deltaP_sym(i, j) = (t_deltaP(i, j) || t_deltaP(j, i));
725  t_deltaP_sym(i, j) /= 2.0;
726  auto t_diff2_uP2 = EigenMatrix::getDiffDiffMat(
727  t_eigen_vals, t_eigen_vecs, EshelbianCore::f, EshelbianCore::d_f,
728  EshelbianCore::dd_f, t_deltaP_sym, nbUniq[gg]);
729  t_dP(L, J) += t_L(i, j, L) * (t_diff2_uP2(i, j, k, l) * t_L(k, l, J));
730  }
731  ++t_eigen_vals;
732  ++t_eigen_vecs;
733 
734  int rr = 0;
735  for (; rr != row_nb_dofs / size_symm; ++rr) {
736  auto t_col_base_fun = col_data.getFTensor0N(gg, 0);
737  auto t_col_grad_fun = col_data.getFTensor1DiffN<3>(gg, 0);
738 
739  auto t_m = get_ftensor2(K, 6 * rr, 0);
740  for (int cc = 0; cc != col_nb_dofs / size_symm; ++cc) {
741  double b = a * t_row_base_fun * t_col_base_fun;
742  double c = (a * alpha_grad_u * ts_a) *
743  (t_row_grad_fun(i) * t_col_grad_fun(i));
744  t_m(L, J) -= b * t_dP(L, J);
745  t_m(L, J) += c * t_kd_sym(L, J);
746 
747  ++t_m;
748  ++t_col_base_fun;
749  ++t_col_grad_fun;
750  }
751  ++t_row_base_fun;
752  ++t_row_grad_fun;
753  }
754 
755  for (; rr != row_nb_base_functions; ++rr) {
756  ++t_row_base_fun;
757  ++t_row_grad_fun;
758  }
759 
760  ++t_P;
761  ++r_P_du;
762  }
764  };
765 
767  case NO_H1_CONFIGURATION:
768  CHKERR large();
769  break;
770  case LARGE_ROT:
771  case MODERATE_ROT:
772  CHKERR large();
773  break;
774  default:
775  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
776  "gradApproximator not handled");
777  };
778 
780 }
781 
782 } // namespace EshelbianPlasticity
NOSPACE
@ NOSPACE
Definition: definitions.h:83
MoFEM::UnknownInterface::getInterface
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.
Definition: UnknownInterface.hpp:93
MoFEM::K
VectorDouble K
Definition: Projection10NodeCoordsOnField.cpp:125
MoFEM::EntitiesFieldData::EntData
Data on single entity (This is passed as argument to DataOperator::doWork)
Definition: EntitiesFieldData.hpp:128
EshelbianPlasticity::HMHNeohookean::mField
MoFEM::Interface & mField
Definition: HMHNeohookean.cpp:213
EshelbianPlasticity::HMHNeohookean::OpSpatialPhysical_du_du::OpSpatialPhysical_du_du
OpSpatialPhysical_du_du(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const double alpha)
Definition: HMHNeohookean.cpp:455
EshelbianPlasticity::HMHNeohookean::blockData
std::vector< BlockData > blockData
Definition: HMHNeohookean.cpp:223
EshelbianPlasticity::size_symm
constexpr static auto size_symm
Definition: EshelbianAux.hpp:41
EshelbianCore::dd_f
static boost::function< double(const double)> dd_f
Definition: EshelbianCore.hpp:34
EshelbianPlasticity::HMHNeohookean::OpSpatialPhysical_du_du::integrate
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
Definition: HMHNeohookean.cpp:464
FTensor::Tensor1
Definition: Tensor1_value.hpp:8
MOFEM_LOG_CHANNEL
#define MOFEM_LOG_CHANNEL(channel)
Set and reset channel.
Definition: LogManager.hpp:284
EntityHandle
MoFEM::ForcesAndSourcesCore::UserDataOperator::OPSPACE
@ OPSPACE
operator do Work is execute on space data
Definition: ForcesAndSourcesCore.hpp:570
EshelbianCore::f
static boost::function< double(const double)> f
Definition: EshelbianCore.hpp:32
EshelbianPlasticity::HMHNeohookean::numberOfActiveVariables
static constexpr int numberOfActiveVariables
Definition: HMHNeohookean.cpp:16
CHK_THROW_MESSAGE
#define CHK_THROW_MESSAGE(err, msg)
Check and throw MoFEM exception.
Definition: definitions.h:609
EshelbianPlasticity::HMHNeohookean::OpSpatialPhysical::OpSpatialPhysical
OpSpatialPhysical(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const double alpha_u)
Definition: HMHNeohookean.cpp:229
EshelbianPlasticity::HMHNeohookean::c10_default
double c10_default
Definition: HMHNeohookean.cpp:215
EshelbianPlasticity::HMHNeohookean::HMHNeohookean
HMHNeohookean(MoFEM::Interface &m_field, const double c10, const double K)
Definition: HMHNeohookean.cpp:19
EshelbianCore::stretchSelector
static enum StretchSelector stretchSelector
Definition: EshelbianCore.hpp:17
MoFEM::Exceptions::MoFEMErrorCode
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
Definition: Exceptions.hpp:56
MoFEM::Types::MatrixDouble
UBlasMatrix< double > MatrixDouble
Definition: Types.hpp:77
EshelbianPlasticity::HMHNeohookean::BlockData
Definition: HMHNeohookean.cpp:218
EshelbianPlasticity::HMHNeohookean::alphaGradU
double alphaGradU
Definition: HMHNeohookean.cpp:217
FTensor::Kronecker_Delta
Kronecker Delta class.
Definition: Kronecker_Delta.hpp:15
EshelbianPlasticity
Definition: CGGTonsorialBubbleBase.hpp:11
EshelbianPlasticity::diff_tensor
auto diff_tensor()
Definition: EshelbianAux.hpp:43
EshelbianPlasticity::HMHNeohookean::eqScaling
double eqScaling
Definition: HMHNeohookean.cpp:225
EshelbianPlasticity::PhysicalEquations
Definition: EshelbianPlasticity.hpp:277
EshelbianPlasticity::HMHNeohookean::OpSpatialPhysical
Definition: HMHNeohookean.cpp:177
J
FTensor::Index< 'J', DIM1 > J
Definition: level_set.cpp:30
FTensor::Tensor2_symmetric
Definition: Tensor2_symmetric_value.hpp:13
EshelbianPlasticity::HMHNeohookean::OpGetScale
Definition: HMHNeohookean.cpp:63
FTENSOR_INDEX
#define FTENSOR_INDEX(DIM, I)
Definition: Templates.hpp:2013
EshelbianPlasticity::NO_H1_CONFIGURATION
@ NO_H1_CONFIGURATION
Definition: EshelbianPlasticity.hpp:45
sdf.r
int r
Definition: sdf.py:8
FTensor::Tensor2
Definition: Tensor2_value.hpp:16
MoFEM::DeprecatedCoreInterface
Deprecated interface functions.
Definition: DeprecatedCoreInterface.hpp:16
MoFEM::invertTensor3by3
MoFEMErrorCode invertTensor3by3(ublas::matrix< T, L, A > &jac_data, ublas::vector< T, A > &det_data, ublas::matrix< T, L, A > &inv_jac_data)
Calculate inverse of tensor rank 2 at integration points.
Definition: Templates.hpp:1588
MoFEM::EntitiesFieldData::EntData::getFTensor0N
FTensor::Tensor0< FTensor::PackPtr< double *, 1 > > getFTensor0N(const FieldApproximationBase base)
Get base function as Tensor0.
Definition: EntitiesFieldData.hpp:1502
EshelbianCore::gradApproximator
static enum RotSelector gradApproximator
Definition: EshelbianCore.hpp:16
EshelbianPlasticity::HMHNeohookean::OpJacobian::evaluateRhs
MoFEMErrorCode evaluateRhs(EntData &data)
Definition: HMHNeohookean.cpp:92
c
const double c
speed of light (cm/ns)
Definition: initial_diffusion.cpp:39
MoFEM::Sev
MoFEM::LogManager::SeverityLevel Sev
Definition: CoreTemplates.hpp:17
EshelbianPlasticity::HMHNeohookean::BlockData::c10
double c10
Definition: HMHNeohookean.cpp:219
CHKERR
#define CHKERR
Inline error check.
Definition: definitions.h:548
FTensor::Tensor3
Definition: Tensor3_value.hpp:12
MoFEM::CoreInterface::get_moab
virtual moab::Interface & get_moab()=0
EshelbianPlasticity::HMHNeohookean::OpSpatialPhysical_du_du
Definition: HMHNeohookean.cpp:196
SPACE_DIM
constexpr int SPACE_DIM
Definition: child_and_parent.cpp:16
a
constexpr double a
Definition: approx_sphere.cpp:30
EshelbianPlasticity::HMHNeohookean::extractBlockData
MoFEMErrorCode extractBlockData(std::vector< const CubitMeshSets * > meshset_vec_ptr, Sev sev)
Definition: HMHNeohookean.cpp:141
EshelbianPlasticity::HMHNeohookean::OpJacobian::evaluateLhs
MoFEMErrorCode evaluateLhs(EntData &data)
Definition: HMHNeohookean.cpp:93
EshelbianPlasticity::HMHNeohookean::OpGetScale::OpGetScale
OpGetScale(boost::shared_ptr< double > scale_ptr, boost::shared_ptr< PhysicalEquations > physics_ptr)
Definition: HMHNeohookean.cpp:64
convert.type
type
Definition: convert.py:64
EshelbianPlasticity::HMHNeohookean::OpGetScale::physicsPtr
boost::shared_ptr< PhysicalEquations > physicsPtr
Definition: HMHNeohookean.cpp:80
EshelbianPlasticity::HMHNeohookean::BlockData::K
double K
Definition: HMHNeohookean.cpp:220
MoFEM::EntitiesFieldData::EntData::getIndices
const VectorInt & getIndices() const
Get global indices of dofs on entity.
Definition: EntitiesFieldData.hpp:1214
EshelbianPlasticity::HMHNeohookean
Definition: HMHNeohookean.cpp:14
EshelbianPlasticity::HMHNeohookean::numberOfDependentVariables
static constexpr int numberOfDependentVariables
Definition: HMHNeohookean.cpp:17
EshelbianPlasticity::HMHNeohookean::recordTape
MoFEMErrorCode recordTape(const int tape, DTensor2Ptr *t_h_ptr)
Definition: HMHNeohookean.cpp:172
MoFEM::L
VectorDouble L
Definition: Projection10NodeCoordsOnField.cpp:124
EshelbianCore::exponentBase
static double exponentBase
Definition: EshelbianCore.hpp:31
EshelbianPlasticity::HMHNeohookean::getMaterialParameters
auto getMaterialParameters(EntityHandle ent)
Definition: HMHNeohookean.cpp:50
EshelbianPlasticity::HMHNeohookean::OpSpatialPhysical::integrate
MoFEMErrorCode integrate(EntData &data)
Definition: HMHNeohookean.cpp:234
EshelbianPlasticity::HMHNeohookean::returnOpSetScale
VolUserDataOperator * returnOpSetScale(boost::shared_ptr< double > scale_ptr, boost::shared_ptr< PhysicalEquations > physics_ptr)
Definition: HMHNeohookean.cpp:84
i
FTensor::Index< 'i', SPACE_DIM > i
Definition: hcurl_divergence_operator_2d.cpp:27
EshelbianPlasticity::HMHNeohookean::OpSpatialPhysical::alphaU
const double alphaU
Definition: HMHNeohookean.cpp:186
t_kd
constexpr auto t_kd
Definition: free_surface.cpp:139
EshelbianPlasticity::symm_L_tensor
auto symm_L_tensor()
Definition: EshelbianAux.hpp:54
MoFEM::VolumeElementForcesAndSourcesCore::UserDataOperator
Definition: VolumeElementForcesAndSourcesCore.hpp:109
EntData
EntitiesFieldData::EntData EntData
Definition: child_and_parent.cpp:37
field_name
constexpr auto field_name
Definition: poisson_2d_homogeneous.cpp:13
FTensor::Index
Definition: Index.hpp:23
convert.n
n
Definition: convert.py:82
EshelbianPlasticity::HMHNeohookean::OpGetScale::scalePtr
boost::shared_ptr< double > scalePtr
Definition: HMHNeohookean.cpp:79
EshelbianPlasticity::HMHNeohookean::K_default
double K_default
Definition: HMHNeohookean.cpp:216
EshelbianPlasticity::HMHNeohookean::BlockData::blockEnts
Range blockEnts
Definition: HMHNeohookean.cpp:221
v
const double v
phase velocity of light in medium (cm/ns)
Definition: initial_diffusion.cpp:40
EshelbianPlasticity::HMHNeohookean::returnOpSpatialPhysical
virtual VolUserDataOperator * returnOpSpatialPhysical(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const double alpha_u)
Definition: HMHNeohookean.cpp:190
Range
EshelbianPlasticity::HMHNeohookean::getOptions
MoFEMErrorCode getOptions()
Definition: HMHNeohookean.cpp:103
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::EntitiesFieldData::EntData::getFTensor1DiffN
FTensor::Tensor1< FTensor::PackPtr< double *, Tensor_Dim >, Tensor_Dim > getFTensor1DiffN(const FieldApproximationBase base)
Get derivatives of base functions.
Definition: EntitiesFieldData.cpp:526
EshelbianPlasticity::HMHNeohookean::extractBlockData
MoFEMErrorCode extractBlockData(Sev sev)
Definition: HMHNeohookean.cpp:128
FTensor::Dg
Definition: Dg_value.hpp:9
EshelbianPlasticity::LARGE_ROT
@ LARGE_ROT
Definition: EshelbianPlasticity.hpp:45
EshelbianPlasticity::LOG
@ LOG
Definition: EshelbianPlasticity.hpp:46
EshelbianPlasticity::HMHNeohookean::returnOpJacobian
virtual EshelbianPlasticity::OpJacobian * returnOpJacobian(const int tag, const bool eval_rhs, const bool eval_lhs, boost::shared_ptr< DataAtIntegrationPts > data_ptr, boost::shared_ptr< PhysicalEquations > physics_ptr)
Definition: HMHNeohookean.cpp:97
MoFEM::EntitiesFieldData::EntData::getN
MatrixDouble & getN(const FieldApproximationBase base)
get base functions this return matrix (nb. of rows is equal to nb. of Gauss pts, nb....
Definition: EntitiesFieldData.hpp:1318
j
FTensor::Index< 'j', 3 > j
Definition: matrix_function.cpp:19
EshelbianPlasticity::HMHNeohookean::OpSpatialPhysical_du_du::alphaU
const double alphaU
Definition: HMHNeohookean.cpp:203
MoFEM::Exceptions::ierr
static MoFEMErrorCodeGeneric< PetscErrorCode > ierr
Definition: Exceptions.hpp:76
lambda
static double lambda
Definition: incompressible_elasticity.cpp:199
MOFEM_DATA_INCONSISTENCY
@ MOFEM_DATA_INCONSISTENCY
Definition: definitions.h:31
EshelbianPlasticity::HMHNeohookean::OpJacobian
Definition: HMHNeohookean.cpp:90
m
FTensor::Index< 'm', 3 > m
Definition: shallow_wave.cpp:80
FTensor::Kronecker_Delta_symmetric
Kronecker Delta class symmetric.
Definition: Kronecker_Delta.hpp:49
EshelbianPlasticity::HMHNeohookean::OpGetScale::doWork
MoFEMErrorCode doWork(int side, EntityType type, EntitiesFieldData::EntData &data)
Definition: HMHNeohookean.cpp:69
EshelbianPlasticity::MODERATE_ROT
@ MODERATE_ROT
Definition: EshelbianPlasticity.hpp:45
k
FTensor::Index< 'k', 3 > k
Definition: matrix_function.cpp:20
MoFEM::DataOperator::sYmm
bool sYmm
If true assume that matrix is symmetric structure.
Definition: DataOperators.hpp:82
MoFEMFunctionReturn
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
Definition: definitions.h:429
CHKERRG
#define CHKERRG(n)
Check error code of MoFEM/MOAB/PETSc function.
Definition: definitions.h:496
MoFEMFunctionBegin
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
Definition: definitions.h:359
l
FTensor::Index< 'l', 3 > l
Definition: matrix_function.cpp:21
EshelbianPlasticity::HMHNeohookean::returnOpSpatialPhysical_du_du
VolUserDataOperator * returnOpSpatialPhysical_du_du(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const double alpha)
Definition: HMHNeohookean.cpp:206
EigenMatrix::getDiffDiffMat
auto getDiffDiffMat(A &&t_val, B &&t_vec, Fun< double > f, Fun< double > d_f, Fun< double > dd_f, C &&t_S, const int nb)
Get the Diff Diff Mat object.
Definition: MatrixFunction.hpp:279
EshelbianCore::d_f
static boost::function< double(const double)> d_f
Definition: EshelbianCore.hpp:33
OpAssembleVolume
Definition: EshelbianOperators.hpp:151