v0.15.0
Loading...
Searching...
No Matches
ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp > Struct Template Reference

#include "tutorials/adv-1/src/ContactOps.hpp"

Inheritance diagram for ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >:
[legend]
Collaboration diagram for ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >:
[legend]

Public Member Functions

 OpConstrainBoundaryLhs_dUImpl (const std::string row_field_name, const std::string col_field_name, boost::shared_ptr< CommonData > common_data_ptr, bool is_axisymmetric=false)
 
MoFEMErrorCode iNtegrate (EntitiesFieldData::EntData &row_data, EntitiesFieldData::EntData &col_data)
 

Public Attributes

SurfaceDistanceFunction surfaceDistanceFunction = surface_distance_function
 
GradSurfaceDistanceFunction gradSurfaceDistanceFunction
 
HessSurfaceDistanceFunction hessSurfaceDistanceFunction
 
boost::shared_ptr< CommonDatacommonDataPtr
 
bool isAxisymmetric
 

Detailed Description

template<int DIM, typename AssemblyBoundaryEleOp>
struct ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >

Definition at line 511 of file ContactOps.hpp.

Constructor & Destructor Documentation

◆ OpConstrainBoundaryLhs_dUImpl()

template<int DIM, typename AssemblyBoundaryEleOp >
ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >::OpConstrainBoundaryLhs_dUImpl ( const std::string row_field_name,
const std::string col_field_name,
boost::shared_ptr< CommonData > common_data_ptr,
bool is_axisymmetric = false )

Definition at line 949 of file ContactOps.hpp.

954 : AssemblyBoundaryEleOp(row_field_name, col_field_name,
955 AssemblyBoundaryEleOp::OPROWCOL),
956 commonDataPtr(common_data_ptr), isAxisymmetric(is_axisymmetric) {
957 AssemblyBoundaryEleOp::sYmm = false;
958}
PetscBool is_axisymmetric
Definition contact.cpp:93
FormsIntegrators< BoundaryEleOp >::Assembly< A >::OpBase AssemblyBoundaryEleOp

Member Function Documentation

◆ iNtegrate()

template<int DIM, typename AssemblyBoundaryEleOp >
MoFEMErrorCode ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >::iNtegrate ( EntitiesFieldData::EntData & row_data,
EntitiesFieldData::EntData & col_data )
Examples
ContactOps.hpp.

Definition at line 962 of file ContactOps.hpp.

964 {
966
967 FTensor::Index<'i', DIM> i;
968 FTensor::Index<'j', DIM> j;
969 FTensor::Index<'k', DIM> k;
970
971 const size_t nb_gauss_pts = AssemblyBoundaryEleOp::getGaussPts().size2();
972 auto &locMat = AssemblyBoundaryEleOp::locMat;
973
974 auto t_normal_at_pts = AssemblyBoundaryEleOp::getFTensor1NormalsAtGaussPts();
975 auto t_traction = getFTensor1FromMat<DIM>(commonDataPtr->contactTraction);
976 auto t_coords = AssemblyBoundaryEleOp::getFTensor1CoordsAtGaussPts();
977
978 auto t_w = AssemblyBoundaryEleOp::getFTensor0IntegrationWeight();
979 auto t_row_base = row_data.getFTensor1N<3>();
980 size_t nb_face_functions = row_data.getN().size2() / 3;
981
982 auto m_spatial_coords = get_spatial_coords(
983 BoundaryEleOp::getFTensor1CoordsAtGaussPts(),
984 getFTensor1FromMat<DIM>(commonDataPtr->contactDisp), nb_gauss_pts);
985 auto m_normals_at_pts = get_normalize_normals(
986 BoundaryEleOp::getFTensor1NormalsAtGaussPts(), nb_gauss_pts);
987
988 auto t_normal = getFTensor1FromMat<3>(m_normals_at_pts);
989
990 auto ts_time = AssemblyBoundaryEleOp::getTStime();
991 auto ts_time_step = AssemblyBoundaryEleOp::getTStimeStep();
992
993 // placeholder to pass boundary block id to python
994 int block_id = 0;
995
996 auto v_sdf =
997 surfaceDistanceFunction(ts_time_step, ts_time, nb_gauss_pts,
998 m_spatial_coords, m_normals_at_pts, block_id);
999
1000 auto m_grad_sdf =
1001 gradSurfaceDistanceFunction(ts_time_step, ts_time, nb_gauss_pts,
1002 m_spatial_coords, m_normals_at_pts, block_id);
1003
1004 auto m_hess_sdf =
1005 hessSurfaceDistanceFunction(ts_time_step, ts_time, nb_gauss_pts,
1006 m_spatial_coords, m_normals_at_pts, block_id);
1007
1008 auto t_sdf = getFTensor0FromVec(v_sdf);
1009 auto t_grad_sdf = getFTensor1FromMat<3>(m_grad_sdf);
1010 auto t_hess_sdf = getFTensor2SymmetricFromMat<3>(m_hess_sdf);
1011
1012 for (size_t gg = 0; gg != nb_gauss_pts; ++gg) {
1013
1014 double jacobian = 1.;
1015 if (isAxisymmetric) {
1016 jacobian = 2. * M_PI * t_coords(0);
1017 }
1018 const double alpha = t_w * jacobian * AssemblyBoundaryEleOp::getMeasure();
1019
1020 auto tn = -t_traction(i) * t_grad_sdf(i);
1021 auto c = constrain(t_sdf, tn);
1022
1024 t_cP(i, j) = (c * t_grad_sdf(i)) * t_grad_sdf(j);
1026 t_cQ(i, j) = kronecker_delta(i, j) - t_cP(i, j);
1027
1029 t_res_dU(i, j) = kronecker_delta(i, j) + t_cP(i, j);
1030
1031 if (c > 0) {
1032 t_res_dU(i, j) +=
1033 (c * cn_contact) *
1034 (t_hess_sdf(i, j) * (t_grad_sdf(k) * t_traction(k)) +
1035 t_grad_sdf(i) * t_hess_sdf(k, j) * t_traction(k)) +
1036 c * t_sdf * t_hess_sdf(i, j);
1037 }
1038
1039 size_t rr = 0;
1040 for (; rr != AssemblyBoundaryEleOp::nbRows / DIM; ++rr) {
1041
1042 auto t_mat = getFTensor2FromArray<DIM, DIM, DIM>(locMat, DIM * rr);
1043
1044 const double row_base = t_row_base(i) * t_normal(i);
1045
1046 auto t_col_base = col_data.getFTensor0N(gg, 0);
1047 for (size_t cc = 0; cc != AssemblyBoundaryEleOp::nbCols / DIM; ++cc) {
1048 const double beta = alpha * row_base * t_col_base;
1049
1050 t_mat(i, j) -= beta * t_res_dU(i, j);
1051
1052 ++t_col_base;
1053 ++t_mat;
1054 }
1055
1056 ++t_row_base;
1057 }
1058 for (; rr < nb_face_functions; ++rr)
1059 ++t_row_base;
1060
1061 ++t_traction;
1062 ++t_coords;
1063 ++t_w;
1064 ++t_normal;
1065 ++t_sdf;
1066 ++t_grad_sdf;
1067 ++t_hess_sdf;
1068 }
1069
1071}
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
#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< 'j', 3 > j
FTensor::Index< 'k', 3 > k
auto get_normalize_normals(FTensor::Tensor1< T1, DIM1 > &&t_normal_at_pts, size_t nb_gauss_pts)
double cn_contact
Definition contact.cpp:99
auto get_spatial_coords(FTensor::Tensor1< T1, DIM1 > &&t_coords, FTensor::Tensor1< T2, DIM2 > &&t_disp, size_t nb_gauss_pts)
double constrain(double sdf, double tn)
constrain function
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

template<int DIM, typename AssemblyBoundaryEleOp >
boost::shared_ptr<CommonData> ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >::commonDataPtr

Definition at line 526 of file ContactOps.hpp.

◆ gradSurfaceDistanceFunction

template<int DIM, typename AssemblyBoundaryEleOp >
GradSurfaceDistanceFunction ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >::gradSurfaceDistanceFunction
Initial value:
=
MatrixDouble grad_surface_distance_function(double delta_t, double t, int nb_gauss_pts, MatrixDouble &m_spatial_coords, MatrixDouble &m_normals_at_pts, int block_id)

Definition at line 521 of file ContactOps.hpp.

◆ hessSurfaceDistanceFunction

template<int DIM, typename AssemblyBoundaryEleOp >
HessSurfaceDistanceFunction ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >::hessSurfaceDistanceFunction
Initial value:
=
MatrixDouble hess_surface_distance_function(double delta_t, double t, int nb_gauss_pts, MatrixDouble &m_spatial_coords, MatrixDouble &m_normals_at_pts, int block_id)

Definition at line 523 of file ContactOps.hpp.

◆ isAxisymmetric

template<int DIM, typename AssemblyBoundaryEleOp >
bool ContactOps::OpConstrainBoundaryLhs_dUImpl< DIM, GAUSS, AssemblyBoundaryEleOp >::isAxisymmetric

Definition at line 527 of file ContactOps.hpp.

◆ surfaceDistanceFunction

Definition at line 520 of file ContactOps.hpp.


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