16 OpJacobian(
const int tag,
const bool eval_rhs,
const bool eval_lhs,
17 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
18 boost::shared_ptr<PhysicalEquations> physics_ptr)
34 boost::shared_ptr<DataAtIntegrationPts>
36 boost::shared_ptr<PhysicalEquations>
45 boost::shared_ptr<DataAtIntegrationPts>
49 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
54 std::string row_field, std::string col_field,
55 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
const char type,
56 const bool assemble_symmetry,
ScaleOff scale_off = []() {
return 1; })
57 : T(row_field, col_field, type, false),
dataAtPts(data_ptr),
75 virtual MoFEMErrorCode
integrate(
int row_side, EntityType row_type,
84 double *vec_ptr = &*
nF.begin();
87 CHKERR VecSetValues(this->getTSf(), nb_dofs, ind_ptr, vec_ptr, ADD_VALUES);
91 virtual MoFEMErrorCode
assemble(
int row_side, EntityType row_type,
104 virtual MoFEMErrorCode
assemble(
int row_side,
int col_side,
105 EntityType row_type, EntityType col_type,
110 const auto row_nb_dofs = row_data.
getIndices().size();
111 const auto col_nb_dofs = col_data.
getIndices().size();
112 transposeK.resize(col_nb_dofs, row_nb_dofs,
false);
117 CHKERR MatSetValues<AssemblyTypeSelector<A>>(this->getTSB(), row_data,
118 col_data,
K, ADD_VALUES);
120 CHKERR MatSetValues<AssemblyTypeSelector<A>>(
121 this->getTSB(), col_data, row_data,
transposeK, ADD_VALUES);
138 MoFEMErrorCode
doWork(
int row_side,
int col_side, EntityType row_type,
139 EntityType col_type,
EntData &row_data,
149 CHKERR assemble(row_side, col_side, row_type, col_type, row_data, col_data);
158 MoFEMErrorCode
assemble(
int row_side,
int col_side, EntityType row_type,
159 EntityType col_type,
EntData &row_data,
164 constexpr bool store_matrices =
false;
165 if constexpr (store_matrices) {
167 m.resize(
K.size1(),
K.size2(),
false);
171 m.resize(
K.size2(),
K.size1(),
false);
179 static inline std::map<std::pair<std::string, std::string>, MatrixDouble>
185 using OP::OpAssembleVolume;
195 using OpAssembleVolume::OpAssembleVolume;
199 "OpAssembleVolumePositiveDefine not implemented");
203 MoFEMErrorCode
doWork(
int row_side,
int col_side, EntityType row_type,
204 EntityType col_type,
EntData &row_data,
215 constexpr bool run_psd =
true;
219 auto symmetrize = [](MatrixDouble &mat) {
220 MatrixDouble r = (mat + trans(mat)) / 2.0;
223 auto check_positive_definite = [](MatrixDouble &mat) {
227 auto frobenius_norm = [](MatrixDouble &mat) {
229 for (std::size_t
i = 0;
i < mat.size1(); ++
i)
230 for (std::size_t
j = 0;
j < mat.size2(); ++
j)
231 sum += mat(
i,
j) * mat(
i,
j);
232 return std::sqrt(sum);
235 auto higham_method_one_pass = [&](MatrixDouble &mat) {
238 const int size = (
n + 2) *
n;
240 double *work =
new double[size];
242 VectorDouble eig(
n, 0.0);
243 MatrixDouble eigen_vec = prod(trans(mat), mat);
245 eig.data().data(), work, lwork) > 0)
247 "The algorithm failed to compute eigenvalues.");
250 for (
auto &e : eig) {
251 constexpr double eps = std::numeric_limits<double>::epsilon();
252 e = std::max(std::sqrt(std::abs(e)),
eps);
255 auto diagonal_matrix =
256 ublas::diagonal_matrix<
double, ublas::row_major,
257 VecAllocator<double>>(
n, eig.data());
258 MatrixDouble symm_mat;
259 symm_mat = prod(trans(eigen_vec), diagonal_matrix);
260 symm_mat = prod(symm_mat, eigen_vec);
262 MatrixDouble hat_m = (mat + symm_mat) / 2.0;
267 auto hat_k = higham_method_one_pass(
K);
271 CHKERR assemble(row_side, col_side, row_type, col_type, row_data, col_data);
281 :
public ForcesAndSourcesCore::UserDataOperator {
288 boost::shared_ptr<DataAtIntegrationPts>
295 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
double alpha_omega = 0)
301 boost::shared_ptr<DataAtIntegrationPts>
308 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
310 std::fill(&doEntities[MBVERTEX], &doEntities[MBMAXTYPE],
false);
311 for (
auto t = moab::CN::TypeDimensionMap[
SPACE_DIM].first;
312 t <= moab::CN::TypeDimensionMap[
SPACE_DIM].second; ++
t)
313 doEntities[
t] =
true;
319 boost::shared_ptr<DataAtIntegrationPts>
325 std::string block_name,
Range block_entities,
326 std::array<double, 6> &reaction_vec)
333 boost::shared_ptr<DataAtIntegrationPts>
342 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
343 const double alpha,
const double rho)
356 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
368 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
377 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
386 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
391template <
int INTERP_ORDER>
394 std::string tag_name =
"")
396 std::fill(&doEntities[MBVERTEX], &doEntities[MBMAXTYPE],
false);
397 doEntities[MBVERTEX] =
true;
410 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
418template <AssemblyType A>
420 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBrokenBase {
422 using OP =
typename FormsIntegrators<FaceUserDataOperator>::Assembly<
426 boost::shared_ptr<std::vector<BrokenBaseSideData>> broken_base_side_data,
427 boost::shared_ptr<BcDispVec> &bc_disp_ptr,
428 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
429 boost::shared_ptr<Range> ents_ptr =
nullptr)
430 :
OP(broken_base_side_data, ents_ptr), bcDispPtr(bc_disp_ptr),
431 scalingMethodsMap(smv) {}
441 using OP::OpDispBcImpl;
449template <AssemblyType A>
451 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBrokenBase {
453 using OP =
typename FormsIntegrators<FaceUserDataOperator>::Assembly<
457 boost::shared_ptr<std::vector<BrokenBaseSideData>> broken_base_side_data,
458 boost::shared_ptr<BcRotVec> &bc_rot_ptr,
459 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
460 boost::shared_ptr<Range> ents_ptr =
nullptr)
461 :
OP(broken_base_side_data, ents_ptr), bcRotPtr(bc_rot_ptr),
462 scalingMethodsMap(smv) {}
482 using OP::OpRotationBcImpl;
489 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase {
491 const std::string row_field, boost::shared_ptr<TractionBcVec> bc_data,
492 boost::shared_ptr<double> piola_scale_ptr,
493 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv)
494 : FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>::
OpBase(
495 row_field, row_field, FaceUserDataOperator::OPROW),
507 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase {
509 const std::string row_field, boost::shared_ptr<PressureBcVec> bc_data,
510 boost::shared_ptr<double> piola_scale_ptr,
511 boost::shared_ptr<MatrixDouble> hybrid_grad_disp,
512 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv)
513 : FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>::
OpBase(
514 row_field, row_field, FaceUserDataOperator::OPROW),
529template <AssemblyType A>
531 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBase {
534 typename FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBase;
537 std::string row_field, boost::shared_ptr<PressureBcVec> bc_data,
538 boost::shared_ptr<MatrixDouble> hybrid_grad_disp,
539 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv)
540 :
OP(row_field, row_field,
OP::OPROWCOL), bcData(bc_data),
541 hybridGradDispPtr(hybrid_grad_disp), scalingMethodsMap(smv) {}
559 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase {
561 const std::string row_field, boost::shared_ptr<AnalyticalTractionBcVec> bc_data,
562 boost::shared_ptr<double> piola_scale_ptr,
563 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv)
564 : FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>::
OpBase(
565 row_field, row_field, FaceUserDataOperator::OPROW),
571 boost::shared_ptr<AnalyticalTractionBcVec>
bcData;
580template <AssemblyType A>
582 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase {
585 typename FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase;
588 std::string row_field, boost::shared_ptr<MatrixDouble> hybrid_disp_ptr,
589 boost::shared_ptr<MatrixDouble> piola_stress_ptr,
590 boost::shared_ptr<NormalDisplacementBcVec> &bc_disp_ptr,
591 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
592 boost::shared_ptr<Range> ents_ptr =
nullptr)
593 : FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>::
OpBase(
594 row_field, row_field,
OP::OPROW),
595 hybridDispPtr(hybrid_disp_ptr), piolaStressPtr(piola_stress_ptr),
596 bcDispPtr(bc_disp_ptr), scalingMethodsMap(smv) {}
606template <AssemblyType A>
608 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBase {
611 typename FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBase;
614 std::string row_field,
615 boost::shared_ptr<NormalDisplacementBcVec> &bc_disp_ptr,
616 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
617 boost::shared_ptr<Range> ents_ptr =
nullptr)
618 :
OP(row_field, row_field,
OP::OPROWCOL), bcDispPtr(bc_disp_ptr),
619 scalingMethodsMap(smv) {}
627template <AssemblyType A>
629 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBrokenBase {
631 using OP =
typename FormsIntegrators<FaceUserDataOperator>::Assembly<
635 std::string row_field,
636 boost::shared_ptr<std::vector<BrokenBaseSideData>> broken_base_side_data,
637 boost::shared_ptr<NormalDisplacementBcVec> &bc_disp_ptr,
638 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
639 boost::shared_ptr<Range> ents_ptr =
nullptr)
640 :
OP(row_field, broken_base_side_data, false, false, ents_ptr),
641 bcDispPtr(bc_disp_ptr), scalingMethodsMap(smv) {}
651 using OP::OpNormalDispBcRhsImpl;
675template <AssemblyType A>
677 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBrokenBase {
679 using OP =
typename FormsIntegrators<FaceUserDataOperator>::Assembly<
683 boost::shared_ptr<std::vector<BrokenBaseSideData>> broken_base_side_data,
684 boost::shared_ptr<AnalyticalDisplacementBcVec> &bc_disp_ptr,
685 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
686 boost::shared_ptr<Range> ents_ptr =
nullptr)
687 :
OP(broken_base_side_data, ents_ptr), bcDispPtr(bc_disp_ptr),
688 scalingMethodsMap(smv) {}
692 boost::shared_ptr<AnalyticalDisplacementBcVec>
bcDispPtr;
698 using OP::OpAnalyticalDispBcImpl;
706 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
707 const bool assemble_off =
false)
719 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
720 const double alpha,
const double rho)
730 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
731 const bool assemble_off =
false)
742 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
743 const bool assemble_off =
false)
753 using OpAssembleVolume::OpAssembleVolume;
755 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
756 const bool assemble_off)
766 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
777 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
778 const bool assemble_off)
788 std::string row_field, std::string col_field,
789 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
const bool assemble_off)
800 std::string row_field, std::string col_field,
801 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
double alpha_omega)
814 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
827 std::string row_field, std::string col_field,
828 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
841 std::string row_field, std::string col_field,
842 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
855 std::string row_field, std::string col_field,
856 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
const bool assemble_off)
868 std::string row_field, std::string col_field,
869 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
const bool assemble_off)
880 :
public VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator {
882 using OP = VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator;
889 std::vector<EntityHandle> &map_gauss_pts,
890 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
903 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
910 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
920 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
928 :
public VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator {
931 using OP = VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator;
939 boost::shared_ptr<DataAtIntegrationPts>
944 :
public FaceElementForcesAndSourcesCore::UserDataOperator {
947 using OP = FaceElementForcesAndSourcesCore::UserDataOperator;
955 boost::shared_ptr<DataAtIntegrationPts>
959template <
int FE_DIM,
int PROBLEM_DIM,
int SPACE_DIM>
struct AddHOOps;
963 static MoFEMErrorCode
964 add(boost::ptr_deque<ForcesAndSourcesCore::UserDataOperator> &pipeline,
965 std::vector<FieldSpace> space, std::string geom_field_name,
966 boost::shared_ptr<Range> crack_front_edges_ptr);
971 static MoFEMErrorCode
972 add(boost::ptr_deque<ForcesAndSourcesCore::UserDataOperator> &pipeline,
973 std::vector<FieldSpace> space, std::string geom_field_name,
974 boost::shared_ptr<Range> crack_front_edges_ptr);
979 static MoFEMErrorCode
980 add(boost::ptr_deque<ForcesAndSourcesCore::UserDataOperator> &pipeline,
981 std::vector<FieldSpace> space, std::string geom_field_name,
982 boost::shared_ptr<Range> crack_front_edges_ptr);
ForcesAndSourcesCore::UserDataOperator UserDataOperator
#define CHK_THROW_MESSAGE(err, msg)
Check and throw MoFEM exception.
#define MoFEMFunctionReturnHot(a)
Last executable line of each PETSc function used for error handling. Replaces return()
FieldSpace
approximation spaces
#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()
#define CHKERR
Inline error check.
FTensor::Index< 'i', SPACE_DIM > i
const double n
refractive index of diffusive medium
static __CLPK_integer lapack_dpotrf(char uplo, __CLPK_integer n, __CLPK_doublereal *a, __CLPK_integer lda)
static __CLPK_integer lapack_dsyev(char jobz, char uplo, __CLPK_integer n, __CLPK_doublereal *a, __CLPK_integer lda, __CLPK_doublereal *w, __CLPK_doublereal *work, __CLPK_integer lwork)
FTensor::Index< 'j', 3 > j
constexpr double t
plate stiffness
constexpr auto field_name
OpBaseImpl< PETSC, EdgeEleOp > OpBase
FTensor::Index< 'm', 3 > m
static MoFEMErrorCode add(boost::ptr_deque< ForcesAndSourcesCore::UserDataOperator > &pipeline, std::vector< FieldSpace > space, std::string geom_field_name, boost::shared_ptr< Range > crack_front_edges_ptr)
static MoFEMErrorCode add(boost::ptr_deque< ForcesAndSourcesCore::UserDataOperator > &pipeline, std::vector< FieldSpace > space, std::string geom_field_name, boost::shared_ptr< Range > crack_front_edges_ptr)
static MoFEMErrorCode add(boost::ptr_deque< ForcesAndSourcesCore::UserDataOperator > &pipeline, std::vector< FieldSpace > space, std::string geom_field_name, boost::shared_ptr< Range > crack_front_edges_ptr)
bool sYmm
If true assume that matrix is symmetric structure.
Data on single entity (This is passed as argument to DataOperator::doWork)
const VectorInt & getIndices() const
Get global indices of dofs on entity.
friend class ForcesAndSourcesCore
@ OPROW
operator doWork function is executed on FE rows
@ OPROWCOL
operator doWork is executed on FE rows &columns
@ OPSPACE
operator do Work is execute on space data
boost::shared_ptr< AnalyticalDisplacementBcVec > bcDispPtr
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
MoFEMErrorCode iNtegrate(EntData &data)
OpAnalyticalDispBcImpl(boost::shared_ptr< std::vector< BrokenBaseSideData > > broken_base_side_data, boost::shared_ptr< AnalyticalDisplacementBcVec > &bc_disp_ptr, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv, boost::shared_ptr< Range > ents_ptr=nullptr)
MoFEMErrorCode iNtegrate(EntData &data)
MatrixDouble K
local tangent matrix
virtual MoFEMErrorCode integrate(int row_side, EntityType row_type, EntData &data)
VectorDouble nF
local right hand side vector
MoFEMErrorCode doWork(int row_side, int col_side, EntityType row_type, EntityType col_type, EntData &row_data, EntData &col_data)
virtual MoFEMErrorCode assemble(int row_side, int col_side, EntityType row_type, EntityType col_type, EntData &row_data, EntData &col_data)
virtual MoFEMErrorCode integrate(EntData &data)
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
virtual MoFEMErrorCode assemble(EntData &data)
OpAssembleBasic(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const char type)
virtual MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
const bool assembleSymmetry
boost::function< double()> ScaleOff
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
OpAssembleBasic(const FieldSpace space)
virtual MoFEMErrorCode assemble(int row_side, EntityType row_type, EntData &data)
OpAssembleBasic(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const char type, const bool assemble_symmetry, ScaleOff scale_off=[]() { return 1;})
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
Operator for linear form, usually to calculate values on right hand side.
MoFEMErrorCode doWork(int row_side, int col_side, EntityType row_type, EntityType col_type, EntData &row_data, EntData &col_data)
Operator for bi-linear form, usually to calculate values on left hand side.
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
Operator for linear form, usually to calculate values on right hand side.
OpAssembleVolumeStabilize()
static std::map< std::pair< std::string, std::string >, MatrixDouble > mapMatrix
MoFEMErrorCode assemble(int row_side, int col_side, EntityType row_type, EntityType col_type, EntData &row_data, EntData &col_data)
boost::shared_ptr< AnalyticalTractionBcVec > bcData
OpBrokenAnalyticalTractionBc(const std::string row_field, boost::shared_ptr< AnalyticalTractionBcVec > bc_data, boost::shared_ptr< double > piola_scale_ptr, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv)
boost::shared_ptr< double > piolaScalePtr
MoFEMErrorCode iNtegrate(EntData &data)
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
MoFEMErrorCode iNtegrate(EntData &row_data, EntData &col_data)
boost::shared_ptr< MatrixDouble > hybridGradDispPtr
OpBrokenPressureBcLhsImpl_dU(std::string row_field, boost::shared_ptr< PressureBcVec > bc_data, boost::shared_ptr< MatrixDouble > hybrid_grad_disp, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv)
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
boost::shared_ptr< PressureBcVec > bcData
MoFEMErrorCode iNtegrate(EntData &row_data, EntData &col_data)
boost::shared_ptr< MatrixDouble > hybridGradDispPtr
boost::shared_ptr< double > piolaScalePtr
MoFEMErrorCode iNtegrate(EntData &data)
OpBrokenPressureBc(const std::string row_field, boost::shared_ptr< PressureBcVec > bc_data, boost::shared_ptr< double > piola_scale_ptr, boost::shared_ptr< MatrixDouble > hybrid_grad_disp, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv)
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
boost::shared_ptr< PressureBcVec > bcData
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
OpBrokenTractionBc(const std::string row_field, boost::shared_ptr< TractionBcVec > bc_data, boost::shared_ptr< double > piola_scale_ptr, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv)
boost::shared_ptr< double > piolaScalePtr
boost::shared_ptr< TractionBcVec > bcData
MoFEMErrorCode iNtegrate(EntData &data)
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
Operator for linear form, usually to calculate values on right hand side.
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
OpCalculateEshelbyStress(boost::shared_ptr< DataAtIntegrationPts > data_ptr)
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
std::array< double, 6 > & reactionVec
OpCalculateReactionForces(boost::shared_ptr< DataAtIntegrationPts > data_ptr, std::string block_name, Range block_entities, std::array< double, 6 > &reaction_vec)
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
Operator for linear form, usually to calculate values on right hand side.
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
OpCalculateRotationAndSpatialGradient(boost::shared_ptr< DataAtIntegrationPts > data_ptr, double alpha_omega=0)
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
OpCalculateTractionFromSideEl(boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
OpDispBcImpl(boost::shared_ptr< std::vector< BrokenBaseSideData > > broken_base_side_data, boost::shared_ptr< BcDispVec > &bc_disp_ptr, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv, boost::shared_ptr< Range > ents_ptr=nullptr)
MoFEMErrorCode iNtegrate(EntData &data)
boost::shared_ptr< BcDispVec > bcDispPtr
MoFEMErrorCode iNtegrate(EntData &data)
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
FaceElementForcesAndSourcesCore::UserDataOperator OP
OpFaceMaterialForce(boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
OpFaceSideMaterialForce(boost::shared_ptr< DataAtIntegrationPts > data_ptr)
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator OP
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
OpGetInternalStress(boost::shared_ptr< DataAtIntegrationPts > data_ptr, std::string tag_name="")
virtual MoFEMErrorCode evaluateLhs(EntData &data)=0
boost::shared_ptr< PhysicalEquations > physicsPtr
material physical equations
virtual MoFEMErrorCode evaluateRhs(EntData &data)=0
OpJacobian(const int tag, const bool eval_rhs, const bool eval_lhs, boost::shared_ptr< DataAtIntegrationPts > data_ptr, boost::shared_ptr< PhysicalEquations > physics_ptr)
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
boost::shared_ptr< NormalDisplacementBcVec > bcDispPtr
OpNormalDispBcLhsImpl_dP(std::string row_field, boost::shared_ptr< std::vector< BrokenBaseSideData > > broken_base_side_data, boost::shared_ptr< NormalDisplacementBcVec > &bc_disp_ptr, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv, boost::shared_ptr< Range > ents_ptr=nullptr)
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
MoFEMErrorCode iNtegrate(EntData &row_data, EntData &col_data)
MoFEMErrorCode iNtegrate(EntData &row_data, EntData &col_data)
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
OpNormalDispBcLhsImpl_dU(std::string row_field, boost::shared_ptr< NormalDisplacementBcVec > &bc_disp_ptr, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv, boost::shared_ptr< Range > ents_ptr=nullptr)
boost::shared_ptr< NormalDisplacementBcVec > bcDispPtr
boost::shared_ptr< MatrixDouble > hybridDispPtr
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
MoFEMErrorCode iNtegrate(EntData &data)
boost::shared_ptr< NormalDisplacementBcVec > bcDispPtr
boost::shared_ptr< MatrixDouble > piolaStressPtr
OpNormalDispBcRhsImpl(std::string row_field, boost::shared_ptr< MatrixDouble > hybrid_disp_ptr, boost::shared_ptr< MatrixDouble > piola_stress_ptr, boost::shared_ptr< NormalDisplacementBcVec > &bc_disp_ptr, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv, boost::shared_ptr< Range > ents_ptr=nullptr)
MoFEMErrorCode iNtegrate(EntData &row_data, EntData &col_data)
MoFEMErrorCode iNtegrate(EntData &row_data, EntData &col_data)
MoFEMErrorCode iNtegrate(EntData &data)
std::vector< EntityHandle > & mapGaussPts
OpPostProcDataStructure(moab::Interface &post_proc_mesh, std::vector< EntityHandle > &map_gauss_pts, boost::shared_ptr< DataAtIntegrationPts > data_ptr, int sense)
moab::Interface & postProcMesh
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator OP
OpRotationBcImpl(boost::shared_ptr< std::vector< BrokenBaseSideData > > broken_base_side_data, boost::shared_ptr< BcRotVec > &bc_rot_ptr, std::map< std::string, boost::shared_ptr< ScalingMethod > > smv, boost::shared_ptr< Range > ents_ptr=nullptr)
MoFEMErrorCode iNtegrate(EntData &data)
std::map< std::string, boost::shared_ptr< ScalingMethod > > scalingMethodsMap
boost::shared_ptr< BcRotVec > bcRotPtr
Apply rotation boundary condition.
MoFEMErrorCode iNtegrate(EntData &data)
MoFEMErrorCode integrate(EntData &data)
OpSpatialConsistencyBubble(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode integrate(EntData &data)
OpSpatialConsistencyDivTerm(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode integrate(EntData &data)
OpSpatialConsistencyP(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialConsistency_dBubble_dBubble(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode integrateImpl(EntData &row_data, EntData &col_data)
OpSpatialConsistency_dBubble_dP(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode integrateImpl(EntData &row_data, EntData &col_data)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialConsistency_dBubble_domega(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const bool assemble_off)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
MoFEMErrorCode integrateImpl(EntData &row_data, EntData &col_data)
OpSpatialConsistency_dP_dP(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialConsistency_dP_domega(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const bool assemble_off)
OpSpatialEquilibrium_dw_dP(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const bool assemble_off=false)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialEquilibrium_dw_dw(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const double alpha, const double rho)
MoFEMErrorCode integrate(EntData &data)
OpSpatialEquilibrium(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const double alpha, const double rho)
MoFEMErrorCode integrate(EntData &row_data)
OpSpatialPhysicalInternalStress(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
OpSpatialPhysical_du_dBubble(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const bool assemble_off=false)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialPhysical_du_dP(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const bool assemble_off=false)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialPhysical_du_domega(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const bool assemble_off)
OpSpatialPrj_dx_dw(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialPrj_dx_dx(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
OpSpatialPrj(std::string row_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr)
MoFEMErrorCode integrate(EntData &row_data)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialRotation_domega_dBubble(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const bool assemble_off)
OpSpatialRotation_domega_dP(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, const bool assemble_off)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialRotation_domega_domega(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, double alpha_omega)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialRotation_domega_du(std::string row_field, std::string col_field, boost::shared_ptr< DataAtIntegrationPts > data_ptr, double alpha_omega)
MoFEMErrorCode integrate(EntData &row_data, EntData &col_data)
OpSpatialRotation(const std::string &field_name, boost::shared_ptr< DataAtIntegrationPts > data_ptr, double alpha_omega)
MoFEMErrorCode integrate(EntData &data)