v0.15.0
Loading...
Searching...
No Matches
EshelbianPlasticity::OpConstrainBoundaryL2Rhs Struct Reference

#include "users_modules/eshelbian_plasticity/src/EshelbianContact.hpp"

Inheritance diagram for EshelbianPlasticity::OpConstrainBoundaryL2Rhs:
[legend]
Collaboration diagram for EshelbianPlasticity::OpConstrainBoundaryL2Rhs:
[legend]

Public Member Functions

 OpConstrainBoundaryL2Rhs (const std::string row_field_name, boost::shared_ptr< ContactOps::CommonData > common_data_ptr, boost::shared_ptr< ContactTree > contact_tree_ptr, boost::shared_ptr< std::map< int, Range > > sdf_map_range_ptr=nullptr)
 
MoFEMErrorCode iNtegrate (EntitiesFieldData::EntData &row_data)
 

Private Attributes

boost::shared_ptr< ContactOps::CommonDatacommonDataPtr
 
boost::shared_ptr< ContactTreecontactTreePtr
 
boost::shared_ptr< std::map< int, Range > > sdfMapRangePtr
 

Detailed Description

Examples
EshelbianPlasticity.cpp.

Definition at line 118 of file EshelbianContact.hpp.

Constructor & Destructor Documentation

◆ OpConstrainBoundaryL2Rhs()

EshelbianPlasticity::OpConstrainBoundaryL2Rhs::OpConstrainBoundaryL2Rhs ( const std::string row_field_name,
boost::shared_ptr< ContactOps::CommonData > common_data_ptr,
boost::shared_ptr< ContactTree > contact_tree_ptr,
boost::shared_ptr< std::map< int, Range > > sdf_map_range_ptr = nullptr )

Definition at line 309 of file EshelbianContact.cpp.

314 : ContactOps::AssemblyBoundaryEleOp(row_field_name, row_field_name,
315 ContactOps::BoundaryEleOp::OPROW),
316 commonDataPtr(common_data_ptr), contactTreePtr(contact_tree_ptr),
317 sdfMapRangePtr(sdf_map_range_ptr) {
318 CHK_THROW_MESSAGE(PetscOptionsGetScalar(PETSC_NULLPTR, "", "-cn",
319 &ContactOps::cn_contact, PETSC_NULLPTR),
320 "get cn failed");
323 PetscOptionsGetScalar(PETSC_NULLPTR, "", "-alpha_contact_const",
324 &ContactOps::alpha_contact_const, PETSC_NULLPTR),
325 "get alpha contact failed");
327 PetscOptionsGetScalar(PETSC_NULLPTR, "", "-alpha_contact_quadratic",
329 "get alpha contact failed");
331 PetscOptionsGetScalar(PETSC_NULLPTR, "", "-airplane_ray_distance",
332 &ContactOps::airplane_ray_distance, PETSC_NULLPTR),
333 "get alpha contact failed");
334
335
336 MOFEM_LOG("EP", Sev::inform) << "cn " << ContactOps::cn_contact;
337 MOFEM_LOG("EP", Sev::inform)
338 << "alpha_contact_const " << ContactOps::alpha_contact_const;
339 MOFEM_LOG("EP", Sev::inform)
340 << "alpha_contact_quadratic " << ContactOps::alpha_contact_quadratic;
341 MOFEM_LOG("EP", Sev::inform)
342 << "airplane_ray_distance " << ContactOps::airplane_ray_distance;
343}
#define CHK_THROW_MESSAGE(err, msg)
Check and throw MoFEM exception.
#define MOFEM_LOG(channel, severity)
Log.
double cn_contact
Definition contact.cpp:99
double alpha_contact_quadratic
double alpha_contact_const
double airplane_ray_distance
FormsIntegrators< BoundaryEleOp >::Assembly< A >::OpBase AssemblyBoundaryEleOp
PetscErrorCode PetscOptionsGetScalar(PetscOptions *, const char pre[], const char name[], PetscScalar *dval, PetscBool *set)
boost::shared_ptr< std::map< int, Range > > sdfMapRangePtr
boost::shared_ptr< ContactOps::CommonData > commonDataPtr
boost::shared_ptr< ContactTree > contactTreePtr

Member Function Documentation

◆ iNtegrate()

MoFEMErrorCode EshelbianPlasticity::OpConstrainBoundaryL2Rhs::iNtegrate ( EntitiesFieldData::EntData & row_data)

Definition at line 346 of file EshelbianContact.cpp.

346 {
348
349 FTensor::Index<'i', 3> i;
350 FTensor::Index<'j', 3> j;
351 FTensor::Index<'k', 3> k;
352 FTensor::Index<'l', 3> l;
353
354 const size_t nb_gauss_pts = getGaussPts().size2();
355
356#ifndef NDEBUG
357 if (commonDataPtr->contactDisp.size2() != nb_gauss_pts) {
358 SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
359 "Wrong number of integration pts %ld != %ld",
360 commonDataPtr->contactDisp.size2(), nb_gauss_pts);
361 }
362#endif // !NDEBUG
363
364 auto &nf = locF;
365 locF.clear();
366
367 auto t_w = getFTensor0IntegrationWeight();
368 auto t_coords = getFTensor1CoordsAtGaussPts();
369 auto t_disp = getFTensor1FromMat<3>(commonDataPtr->contactDisp);
370 auto t_traction = getFTensor1FromMat<3>(commonDataPtr->contactTraction);
371
372 // placeholder to pass boundary block id to python. default SDF is set on
373 // block = -1, one can choose different block by making block "CONTACT_SDF",
374 // then specific SDF can be set to that block.
375 auto [block_id, m_normals_at_pts, v_sdf, m_grad_sdf, m_hess_sdf] =
376 getSdf(this, commonDataPtr->contactDisp,
377 checkSdf(getFEEntityHandle(), *sdfMapRangePtr), false);
378
379 auto t_sdf_v = getFTensor0FromVec(v_sdf);
380 auto t_grad_sdf_v = getFTensor1FromMat<3>(m_grad_sdf);
381 auto t_normalize_normal = getFTensor1FromMat<3>(m_normals_at_pts);
382
383 auto next = [&]() {
384 ++t_w;
385 ++t_coords;
386 ++t_disp;
387 ++t_traction;
388 ++t_normalize_normal;
389 ++t_sdf_v;
390 ++t_grad_sdf_v;
391 };
392
393 auto face_data_vec_ptr =
394 contactTreePtr->findFaceDataVecPtr(getFEEntityHandle());
395 auto face_gauss_pts_it = face_data_vec_ptr->begin();
396
397 auto nb_base_functions = data.getN().size2();
398 auto t_base = data.getFTensor0N();
399 for (auto gg = 0; gg != nb_gauss_pts; ++gg) {
400
402 auto face_data_ptr = contactTreePtr->getFaceDataPtr(face_gauss_pts_it, gg,
403 face_data_vec_ptr);
404
405 auto check_face_contact = [&]() {
406
407 if (checkSdf(getFEEntityHandle(), *sdfMapRangePtr) != -1)
408 return false;
409
410 if (face_data_ptr) {
411 return true;
412 }
413 return false;
414 };
415
416#ifdef ENABLE_PYTHON_BINDING
417 double c = 0.;
418 if (ContactOps::sdfPythonWeakPtr.lock()) {
419 auto tn = t_traction(i) * t_grad_sdf_v(i);
420 c = ContactOps::constrain(t_sdf_v, tn);
421 }
422#else
423 constexpr double c = 0;
424#endif
425
426 if (!c && check_face_contact()) {
427 FTensor::Tensor1<double, 3> t_spatial_coords;
428 t_spatial_coords(i) = t_coords(i) + t_disp(i);
429 auto t_rhs_tmp =
430 multiPointRhs(face_data_ptr, t_coords, t_spatial_coords, t_traction,
432 t_rhs(i) = t_rhs_tmp(i);
433
434 } else {
435
436#ifdef ENABLE_PYTHON_BINDING
438
439 if (ContactOps::sdfPythonWeakPtr.lock()) {
441 t_cP(i, j) = (c * t_grad_sdf_v(i)) * t_grad_sdf_v(j);
442 t_cQ(i, j) = kronecker_delta(i, j) - t_cP(i, j);
443 t_rhs(i) = t_cQ(i, j) * t_traction(j) +
444 (c * inv_cn * t_sdf_v) * t_grad_sdf_v(i);
445 } else {
446 t_rhs(i) = t_traction(i);
447 }
448#else
449 t_rhs(i) = t_traction(i);
450#endif
451 }
452
453 auto t_nf = getFTensor1FromPtr<3>(&nf[0]);
454 const double alpha = t_w * getMeasure();
455
456 size_t bb = 0;
457 for (; bb != nbRows / 3; ++bb) {
458 const double beta = alpha * t_base;
459 t_nf(i) -= beta * t_rhs(i);
460 ++t_nf;
461 ++t_base;
462 }
463 for (; bb < nb_base_functions; ++bb)
464 ++t_base;
465
466 next();
467 }
468
470}
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
@ MOFEM_DATA_INCONSISTENCY
Definition definitions.h:31
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
FTensor::Index< 'i', SPACE_DIM > i
const double c
speed of light (cm/ns)
FTensor::Index< 'l', 3 > l
FTensor::Index< 'j', 3 > j
FTensor::Index< 'k', 3 > k
double constrain(double sdf, double tn)
constrain function
auto checkSdf(EntityHandle fe_ent, std::map< int, Range > &sdf_map_range)
auto multiPointRhs(ContactTree::FaceData *face_data_ptr, FTensor::Tensor1< T1, 3 > &t_coords, FTensor::Tensor1< T2, 3 > &t_spatial_coords, FTensor::Tensor1< T3, 3 > &t_master_traction, MultiPointRhsType type, bool debug=false)
auto getSdf(OP_PTR op_ptr, MatrixDouble &contact_disp, int block_id, bool eval_hessian)
Tensor2_Expr< Kronecker_Delta< T >, T, Dim0, Dim1, i, j > kronecker_delta(const Index< i, Dim0 > &, const Index< j, Dim1 > &)
Rank 2.

Member Data Documentation

◆ commonDataPtr

boost::shared_ptr<ContactOps::CommonData> EshelbianPlasticity::OpConstrainBoundaryL2Rhs::commonDataPtr
private

Definition at line 128 of file EshelbianContact.hpp.

◆ contactTreePtr

boost::shared_ptr<ContactTree> EshelbianPlasticity::OpConstrainBoundaryL2Rhs::contactTreePtr
private

Definition at line 129 of file EshelbianContact.hpp.

◆ sdfMapRangePtr

boost::shared_ptr<std::map<int, Range> > EshelbianPlasticity::OpConstrainBoundaryL2Rhs::sdfMapRangePtr
private

Definition at line 130 of file EshelbianContact.hpp.


The documentation for this struct was generated from the following files: