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)
25 MoFEMErrorCode
doWork(
int side, EntityType type,
EntData &data);
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>
189 using OpAssembleVolume::OpAssembleVolume;
193 "OpAssembleVolumePositiveDefine not implemented");
197 MoFEMErrorCode
doWork(
int row_side,
int col_side, EntityType row_type,
198 EntityType col_type,
EntData &row_data,
209 constexpr bool run_psd =
true;
213 auto symmetrize = [](MatrixDouble &mat) {
214 MatrixDouble r = (mat + trans(mat)) / 2.0;
217 auto check_positive_definite = [](MatrixDouble &mat) {
221 auto frobenius_norm = [](MatrixDouble &mat) {
223 for (std::size_t
i = 0;
i < mat.size1(); ++
i)
224 for (std::size_t
j = 0;
j < mat.size2(); ++
j)
225 sum += mat(
i,
j) * mat(
i,
j);
226 return std::sqrt(sum);
229 auto higham_method_one_pass = [&](MatrixDouble &mat) {
232 const int size = (
n + 2) *
n;
234 double *work =
new double[size];
236 VectorDouble eig(
n, 0.0);
237 MatrixDouble eigen_vec = prod(trans(mat), mat);
239 eig.data().data(), work, lwork) > 0)
241 "The algorithm failed to compute eigenvalues.");
244 for (
auto &e : eig) {
245 constexpr double eps = std::numeric_limits<double>::epsilon();
246 e = std::max(std::sqrt(std::abs(e)),
eps);
249 auto diagonal_matrix =
250 ublas::diagonal_matrix<
double, ublas::row_major,
251 VecAllocator<double>>(
n, eig.data());
252 MatrixDouble symm_mat;
253 symm_mat = prod(trans(eigen_vec), diagonal_matrix);
254 symm_mat = prod(symm_mat, eigen_vec);
256 MatrixDouble hat_m = (mat + symm_mat) / 2.0;
261 auto hat_k = higham_method_one_pass(
K);
265 CHKERR assemble(row_side, col_side, row_type, col_type, row_data, col_data);
275 :
public ForcesAndSourcesCore::UserDataOperator {
282 boost::shared_ptr<DataAtIntegrationPts>
289 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
double alpha_omega = 0)
292 MoFEMErrorCode
doWork(
int side, EntityType type,
EntData &data);
295 boost::shared_ptr<DataAtIntegrationPts>
302 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
304 std::fill(&doEntities[MBVERTEX], &doEntities[MBMAXTYPE],
false);
305 for (
auto t = moab::CN::TypeDimensionMap[
SPACE_DIM].first;
306 t <= moab::CN::TypeDimensionMap[
SPACE_DIM].second; ++
t)
307 doEntities[
t] =
true;
310 MoFEMErrorCode
doWork(
int side, EntityType type,
EntData &data);
313 boost::shared_ptr<DataAtIntegrationPts>
319 std::string block_name,
Range block_entities,
320 std::array<double, 6> &reaction_vec)
324 MoFEMErrorCode
doWork(
int side, EntityType type,
EntData &data);
327 boost::shared_ptr<DataAtIntegrationPts>
336 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
337 const double alpha,
const double rho)
350 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
362 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
371 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
380 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
385template <
int INTERP_ORDER>
388 std::string tag_name =
"")
390 std::fill(&doEntities[MBVERTEX], &doEntities[MBMAXTYPE],
false);
391 doEntities[MBVERTEX] =
true;
404 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
412template <AssemblyType A>
414 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBrokenBase {
416 using OP =
typename FormsIntegrators<FaceUserDataOperator>::Assembly<
420 boost::shared_ptr<std::vector<BrokenBaseSideData>> broken_base_side_data,
421 boost::shared_ptr<BcDispVec> &bc_disp_ptr,
422 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
423 boost::shared_ptr<Range> ents_ptr =
nullptr)
424 :
OP(broken_base_side_data, ents_ptr), bcDispPtr(bc_disp_ptr),
425 scalingMethodsMap(smv) {}
435 using OP::OpDispBcImpl;
443template <AssemblyType A>
445 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBrokenBase {
447 using OP =
typename FormsIntegrators<FaceUserDataOperator>::Assembly<
451 boost::shared_ptr<std::vector<BrokenBaseSideData>> broken_base_side_data,
452 boost::shared_ptr<BcRotVec> &bc_rot_ptr,
453 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
454 boost::shared_ptr<Range> ents_ptr =
nullptr)
455 :
OP(broken_base_side_data, ents_ptr), bcRotPtr(bc_rot_ptr),
456 scalingMethodsMap(smv) {}
476 using OP::OpRotationBcImpl;
483 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase {
485 const std::string row_field, boost::shared_ptr<TractionBcVec> bc_data,
486 boost::shared_ptr<double> piola_scale_ptr,
487 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv)
488 : FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>::
OpBase(
489 row_field, row_field, FaceUserDataOperator::OPROW),
501 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase {
503 const std::string row_field, boost::shared_ptr<PressureBcVec> bc_data,
504 boost::shared_ptr<double> piola_scale_ptr,
505 boost::shared_ptr<MatrixDouble> hybrid_grad_disp,
506 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv)
507 : FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>::
OpBase(
508 row_field, row_field, FaceUserDataOperator::OPROW),
523template <AssemblyType A>
525 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBase {
528 typename FormsIntegrators<FaceUserDataOperator>::Assembly<
A>
::OpBase;
531 std::string row_field, boost::shared_ptr<PressureBcVec> bc_data,
532 boost::shared_ptr<MatrixDouble> hybrid_grad_disp,
533 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv)
534 :
OP(row_field, row_field,
OP::OPROWCOL), bcData(bc_data),
535 hybridGradDispPtr(hybrid_grad_disp), scalingMethodsMap(smv) {}
553 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase {
555 const std::string row_field, boost::shared_ptr<AnalyticalTractionBcVec> bc_data,
556 boost::shared_ptr<double> piola_scale_ptr,
557 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv)
558 : FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>::
OpBase(
559 row_field, row_field, FaceUserDataOperator::OPROW),
565 boost::shared_ptr<AnalyticalTractionBcVec>
bcData;
574template <AssemblyType A>
576 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase {
579 typename FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>
::OpBase;
582 std::string row_field, boost::shared_ptr<MatrixDouble> hybrid_disp_ptr,
583 boost::shared_ptr<MatrixDouble> piola_stress_ptr,
584 boost::shared_ptr<NormalDisplacementBcVec> &bc_disp_ptr,
585 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
586 boost::shared_ptr<Range> ents_ptr =
nullptr)
587 : FormsIntegrators<FaceUserDataOperator>::Assembly<PETSC>::
OpBase(
588 row_field, row_field,
OP::OPROW),
589 hybridDispPtr(hybrid_disp_ptr), piolaStressPtr(piola_stress_ptr),
590 bcDispPtr(bc_disp_ptr), scalingMethodsMap(smv) {}
600template <AssemblyType A>
602 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBase {
605 typename FormsIntegrators<FaceUserDataOperator>::Assembly<
A>
::OpBase;
608 std::string row_field,
609 boost::shared_ptr<NormalDisplacementBcVec> &bc_disp_ptr,
610 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
611 boost::shared_ptr<Range> ents_ptr =
nullptr)
612 :
OP(row_field, row_field,
OP::OPROWCOL), bcDispPtr(bc_disp_ptr),
613 scalingMethodsMap(smv) {}
621template <AssemblyType A>
623 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBrokenBase {
625 using OP =
typename FormsIntegrators<FaceUserDataOperator>::Assembly<
629 std::string row_field,
630 boost::shared_ptr<std::vector<BrokenBaseSideData>> broken_base_side_data,
631 boost::shared_ptr<NormalDisplacementBcVec> &bc_disp_ptr,
632 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
633 boost::shared_ptr<Range> ents_ptr =
nullptr)
634 :
OP(row_field, broken_base_side_data, false, false, ents_ptr),
635 bcDispPtr(bc_disp_ptr), scalingMethodsMap(smv) {}
645 using OP::OpNormalDispBcRhsImpl;
669template <AssemblyType A>
671 :
public FormsIntegrators<FaceUserDataOperator>::Assembly<A>
::OpBrokenBase {
673 using OP =
typename FormsIntegrators<FaceUserDataOperator>::Assembly<
677 boost::shared_ptr<std::vector<BrokenBaseSideData>> broken_base_side_data,
678 boost::shared_ptr<AnalyticalDisplacementBcVec> &bc_disp_ptr,
679 std::map<std::string, boost::shared_ptr<ScalingMethod>> smv,
680 boost::shared_ptr<Range> ents_ptr =
nullptr)
681 :
OP(broken_base_side_data, ents_ptr), bcDispPtr(bc_disp_ptr),
682 scalingMethodsMap(smv) {}
686 boost::shared_ptr<AnalyticalDisplacementBcVec>
bcDispPtr;
692 using OP::OpAnalyticalDispBcImpl;
700 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
701 const bool assemble_off =
false)
713 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
714 const double alpha,
const double rho)
724 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
725 const bool assemble_off =
false)
736 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
737 const bool assemble_off =
false)
747 using OpAssembleVolume::OpAssembleVolume;
749 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
750 const bool assemble_off)
760 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
771 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
772 const bool assemble_off)
782 std::string row_field, std::string col_field,
783 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
const bool assemble_off)
794 std::string row_field, std::string col_field,
795 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
double alpha_omega)
808 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
821 std::string row_field, std::string col_field,
822 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
835 std::string row_field, std::string col_field,
836 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
849 std::string row_field, std::string col_field,
850 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
const bool assemble_off)
862 std::string row_field, std::string col_field,
863 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
const bool assemble_off)
874 :
public VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator {
876 using OP = VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator;
883 std::vector<EntityHandle> &map_gauss_pts,
884 boost::shared_ptr<DataAtIntegrationPts> data_ptr,
889 MoFEMErrorCode
doWork(
int side, EntityType type,
EntData &data);
897 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
904 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
914 boost::shared_ptr<DataAtIntegrationPts> data_ptr)
922 :
public VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator {
925 using OP = VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator;
930 MoFEMErrorCode
doWork(
int side, EntityType type,
EntData &data);
933 boost::shared_ptr<DataAtIntegrationPts>
938 :
public FaceElementForcesAndSourcesCore::UserDataOperator {
941 using OP = FaceElementForcesAndSourcesCore::UserDataOperator;
946 MoFEMErrorCode
doWork(
int side, EntityType type,
EntData &data);
949 boost::shared_ptr<DataAtIntegrationPts>
953template <
int FE_DIM,
int PROBLEM_DIM,
int SPACE_DIM>
struct AddHOOps;
957 static MoFEMErrorCode
958 add(boost::ptr_deque<ForcesAndSourcesCore::UserDataOperator> &pipeline,
959 std::vector<FieldSpace> space, std::string geom_field_name,
960 boost::shared_ptr<Range> crack_front_edges_ptr);
965 static MoFEMErrorCode
966 add(boost::ptr_deque<ForcesAndSourcesCore::UserDataOperator> &pipeline,
967 std::vector<FieldSpace> space, std::string geom_field_name,
968 boost::shared_ptr<Range> crack_front_edges_ptr);
973 static MoFEMErrorCode
974 add(boost::ptr_deque<ForcesAndSourcesCore::UserDataOperator> &pipeline,
975 std::vector<FieldSpace> space, std::string geom_field_name,
976 boost::shared_ptr<Range> crack_front_edges_ptr,
977 boost::shared_ptr<MatrixDouble> jac =
nullptr,
978 boost::shared_ptr<VectorDouble> det =
nullptr,
979 boost::shared_ptr<MatrixDouble> inv_jac =
nullptr);
988 MoFEMErrorCode
doWork(
int side, EntityType type,
EntData &data);
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, boost::shared_ptr< MatrixDouble > jac=nullptr, boost::shared_ptr< VectorDouble > det=nullptr, boost::shared_ptr< MatrixDouble > inv_jac=nullptr)
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 degrees of freedom 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.
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)
Caluclate face material force and normal pressure at gauss points.
OpFaceSideMaterialForce(boost::shared_ptr< DataAtIntegrationPts > data_ptr)
boost::shared_ptr< DataAtIntegrationPts > dataAtPts
data at integration pts
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)
Zeroes the DOFs which aro not at side for broken base field.
OpZeroNoSideBrokenDofs(std::string field_name)
MoFEMErrorCode doWork(int side, EntityType type, EntData &data)
EleOnSide::UserDataOperator SideEleOp