60 dataH1Master(*dataOnMaster[
H1].get()),
61 dataH1Slave(*dataOnSlave[
H1].get()),
62 dataNoFieldSlave(*dataOnSlave[
NOFIELD].get()),
63 dataNoFieldMaster(*dataOnMaster[
NOFIELD].get()),
64 dataHcurlMaster(*dataOnMaster[
HCURL].get()),
65 dataHcurlSlave(*dataOnSlave[
HCURL].get()),
66 dataHdivMaster(*dataOnMaster[
HDIV].get()),
67 dataL2Master(*dataOnMaster[
L2].get()),
68 dataHdivSlave(*dataOnSlave[
HDIV].get()),
69 dataL2Slave(*dataOnSlave[
L2].get()), opContravariantTransform() {
96 "Problem with creation data on element");
132 double *shape_ptr_master =
135 shape_ptr_master, 1);
136 double *shape_ptr_slave =
160 auto get_coord_and_normal = [&]() {
165 coords.resize(num_nodes * 3,
false);
179 auto get_vec_ptr = [](
VectorDouble &vec_double,
int r = 0) {
181 &vec_double(r + 0), &vec_double(r + 1), &vec_double(r + 2));
184 auto t_coords_master = get_vec_ptr(
coords);
185 auto t_coords_slave = get_vec_ptr(
coords, 9);
186 auto t_normal_master = get_vec_ptr(
normal);
187 auto t_normal_slave = get_vec_ptr(
normal, 3);
196 &diff_ptr[0], &diff_ptr[1]);
204 for (
int nn = 0; nn != 3; ++nn) {
205 t_t1_master(
i) += t_coords_master(
i) * t_diff(
N0);
206 t_t1_slave(
i) += t_coords_slave(
i) * t_diff(
N0);
212 aRea[0] = sqrt(t_normal_master(
i) * t_normal_master(
i)) / 2.;
213 aRea[1] = sqrt(t_normal_slave(
i) * t_normal_slave(
i)) / 2.;
222 CHKERR get_coord_and_normal();
236 CHKERR getEntitySense<MBEDGE>(data_curl);
237 CHKERR getEntityDataOrder<MBEDGE>(data_curl,
HCURL);
238 CHKERR getEntitySense<MBTRI>(data_curl);
239 CHKERR getEntityDataOrder<MBTRI>(data_curl,
HCURL);
244 CHKERR getEntitySense<MBTRI>(data_div);
245 CHKERR getEntityDataOrder<MBTRI>(data_div,
HDIV);
253 CHKERR getEntitySense<MBTRI>(data_l2);
254 CHKERR getEntityDataOrder<MBTRI>(data_l2,
L2);
262 data.spacesOnEntities[
t].reset();
263 data.basesOnEntities[
t].reset();
266 data.basesOnSpaces[s].reset();
275 if (shift != 0 && shift != 6) {
277 "Wrong shift for contact prism element");
280 data.
sPace = copy_data.sPace;
281 data.
bAse = copy_data.bAse;
282 for (
auto t : {MBVERTEX, MBEDGE, MBTRI}) {
288 for (
int ii = 0; ii != 3; ++ii) {
290 copy_data.dataOnEntities[MBEDGE][ii + shift].getSense();
292 copy_data.dataOnEntities[MBEDGE][ii + shift].getOrder();
297 copy_data.dataOnEntities[MBTRI][3].getSense();
299 copy_data.dataOnEntities[MBTRI][3].getOrder();
302 copy_data.dataOnEntities[MBTRI][4].getSense();
304 copy_data.dataOnEntities[MBTRI][4].getOrder();
315 if (shift != 3 && shift != 4) {
317 "Wrong shift for contact prism element");
320 data.
sPace = copy_data.sPace;
321 data.
bAse = copy_data.bAse;
323 for (
auto t : {MBVERTEX, MBTRI}) {
329 auto &cpy_ent_dat = copy_data.dataOnEntities[MBTRI][shift];
331 ent_dat.getBase() = cpy_ent_dat.getBase();
332 ent_dat.getSpace() = cpy_ent_dat.getSpace();
333 ent_dat.getSense() = ent_dat.getSense();
334 ent_dat.getOrder() = cpy_ent_dat.getOrder();
347 int rule =
getRule(order_row, order_col, order_data);
359 "Number of Gauss Points at Master triangle is different than slave");
376 CHKERR Tools::shapeFunMBTRI<1>(
390 for (
int dd = 0; dd < 3; dd++) {
452 &
m(0, 0), &
m(0, 1), &
m(0, 2));
481 "Not yet implemented");
485 "Not yet implemented");
490 "Not yet implemented");
505 constexpr std::array<UserDataOperator::OpType, 2> types{
506 UserDataOperator::OPROW, UserDataOperator::OPCOL};
507 std::array<std::string, 2> last_eval_field_name{std::string(), std::string()};
512 for (; oit != hi_oit; oit++) {
516 if (oit->opType == UserDataOperator::OPSPACE) {
519 switch (oit->sPace) {
530 "Not implemented for this space", oit->sPace);
535 dataOnSlave[oit->sPace]->resetFieldDependentData();
545 boost::shared_ptr<EntitiesFieldData> op_master_data[2];
546 boost::shared_ptr<EntitiesFieldData> op_slave_data[2];
548 for (
int ss = 0; ss != 2; ss++) {
551 !ss ? oit->rowFieldName : oit->colFieldName;
560 if ((oit->getNumeredEntFiniteElementPtr()->getBitFieldIdData() &
564 "no data field < %s > on finite element < %s >",
567 if (oit->getOpType() & types[ss] ||
568 oit->getOpType() & UserDataOperator::OPROWCOL) {
582 "Not implemented for this space", space);
591 boost::weak_ptr<EntityCacheNumeredDofs>
592 operator()(boost::shared_ptr<FieldEntity> &e) {
593 return e->entityCacheRowDofs;
599 MBPRISM, Extractor());
602 boost::weak_ptr<EntityCacheNumeredDofs>
603 operator()(boost::shared_ptr<FieldEntity> &e) {
604 return e->entityCacheColDofs;
609 MBPRISM, Extractor());
619 auto get_indices = [&](
auto &master,
auto &slave,
auto &ents,
623 master.dataOnEntities[MBVERTEX][0].getIndices(),
624 master.dataOnEntities[MBVERTEX][0].getLocalIndices(),
625 slave.dataOnEntities[MBVERTEX][0].getIndices(),
626 slave.dataOnEntities[MBVERTEX][0].getLocalIndices(), ex);
634 slave_data.dataOnEntities[MBVERTEX][0].getFieldData(),
636 slave_data.dataOnEntities[MBVERTEX][0].getFieldDofs(),
638 slave_data.dataOnEntities[MBVERTEX][0].getFieldEntities(),
640 slave_data.dataOnEntities[MBVERTEX][0].getSpace(),
642 slave_data.dataOnEntities[MBVERTEX][0].getBase());
648 boost::weak_ptr<EntityCacheNumeredDofs>
649 operator()(boost::shared_ptr<FieldEntity> &e) {
650 return e->entityCacheRowDofs;
654 CHKERR get_indices(*op_master_data[ss], *op_slave_data[ss],
658 boost::weak_ptr<EntityCacheNumeredDofs>
659 operator()(boost::shared_ptr<FieldEntity> &e) {
660 return e->entityCacheColDofs;
664 CHKERR get_indices(*op_master_data[ss], *op_slave_data[ss],
668 CHKERR get_data(*op_master_data[ss], *op_slave_data[ss]);
693 "Not implemented for this space", space);
704 type = cast_oit->getFaceType();
705 if (((oit->getOpType() & UserDataOperator::OPROW) ||
706 (oit->getOpType() & UserDataOperator::OPCOL)) &&
707 ((type & UserDataOperator::FACEMASTERMASTER) ||
708 (type & UserDataOperator::FACEMASTERSLAVE) ||
709 (type & UserDataOperator::FACESLAVEMASTER) ||
710 (type & UserDataOperator::FACESLAVESLAVE))) {
712 "Wrong combination of FaceType and OpType, OPROW or OPCOL "
713 "combined with face-face OpType");
716 if ((oit->getOpType() & UserDataOperator::OPROWCOL) &&
717 ((type & UserDataOperator::FACEMASTER) ||
718 (type & UserDataOperator::FACESLAVE))) {
720 "Wrong combination of FaceType and OpType, OPROWCOL "
721 "combined with face-face OpType");
726 "Face type is not set");
729 type = UserDataOperator::FACEMASTER | UserDataOperator::FACESLAVE |
730 UserDataOperator::FACEMASTERMASTER |
731 UserDataOperator::FACEMASTERSLAVE |
732 UserDataOperator::FACESLAVEMASTER |
733 UserDataOperator::FACESLAVESLAVE;
736 if (oit->getOpType() & UserDataOperator::OPROW &&
737 (type & UserDataOperator::FACEMASTER)) {
739 CHKERR oit->opRhs(*op_master_data[0],
false);
744 if (oit->getOpType() & UserDataOperator::OPROW &&
745 (type & UserDataOperator::FACESLAVE)) {
747 CHKERR oit->opRhs(*op_slave_data[0],
false);
752 if (oit->getOpType() & UserDataOperator::OPCOL &&
753 (type & UserDataOperator::FACEMASTER)) {
755 CHKERR oit->opRhs(*op_master_data[1],
false);
760 if (oit->getOpType() & UserDataOperator::OPCOL &&
761 (type & UserDataOperator::FACESLAVE)) {
763 CHKERR oit->opRhs(*op_slave_data[1],
false);
768 if (oit->getOpType() & UserDataOperator::OPROWCOL &&
769 (type & UserDataOperator::FACEMASTERMASTER)) {
771 CHKERR oit->opLhs(*op_master_data[0], *op_master_data[1]);
776 if (oit->getOpType() & UserDataOperator::OPROWCOL &&
777 (type & UserDataOperator::FACEMASTERSLAVE)) {
779 CHKERR oit->opLhs(*op_master_data[0], *op_slave_data[1]);
784 if (oit->getOpType() & UserDataOperator::OPROWCOL &&
785 (type & UserDataOperator::FACESLAVEMASTER)) {
787 CHKERR oit->opLhs(*op_slave_data[0], *op_master_data[1]);
792 if (oit->getOpType() & UserDataOperator::OPROWCOL &&
793 (type & UserDataOperator::FACESLAVESLAVE)) {
795 CHKERR oit->opLhs(*op_slave_data[0], *op_slave_data[1]);
810 auto reset_data = [type_lo, type_hi](
auto &data) {
812 for (
auto &dat : data.dataOnEntities[
t]) {
816 dat.getFieldData().resize(0,
false);
817 dat.getFieldDofs().resize(0,
false);
818 dat.getFieldEntities().resize(0,
false);
822 reset_data(master_data);
823 reset_data(slave_data);
829 auto lo = std::lower_bound(field_ents.begin(), field_ents.end(), lo_uid,
831 if (lo != field_ents.end()) {
834 auto hi = std::upper_bound(lo, field_ents.end(), hi_uid,
cmp_uid_hi);
836 for (
auto it = lo; it != hi; ++it)
837 if (
auto e = it->lock()) {
839 auto get_data = [&](
auto &data,
auto type,
auto side) {
840 auto &dat = data.dataOnEntities[type][side];
841 auto &ent_field_dofs = dat.getFieldDofs();
842 auto &ent_field_data = dat.getFieldData();
843 dat.getFieldEntities().resize(1,
false);
844 dat.getFieldEntities()[0] = e.get();
845 dat.getBase() = e->getApproxBase();
846 dat.getSpace() = e->getSpace();
847 const int ent_order = e->getMaxOrder();
849 dat.getOrder() > ent_order ? dat.getOrder() : ent_order;
850 const auto dof_ent_field_data = e->getEntFieldData();
851 const int nb_dofs_on_ent = e->getNbDofsOnEnt();
852 ent_field_data.resize(nb_dofs_on_ent,
false);
853 noalias(ent_field_data) = e->getEntFieldData();
854 ent_field_dofs.resize(nb_dofs_on_ent,
false);
855 std::fill(ent_field_dofs.begin(), ent_field_dofs.end(),
nullptr);
856 if (
auto cache = e->entityCacheDataDofs.lock()) {
857 for (
auto dit =
cache->loHi[0]; dit !=
cache->loHi[1]; ++dit) {
858 ent_field_dofs[(*dit)->getEntDofIdx()] =
865 const int side = e->getSideNumberPtr()->side_number;
871 get_data(master_data, type, side);
873 get_data(slave_data, type, side - 6);
879 get_data(master_data, type, 0);
881 get_data(slave_data, type, 0);
886 "Entity type not implemented (FIXME)");
889 const int brother_side = e->getSideNumberPtr()->brother_side_number;
890 if (brother_side != -1)
892 "Case with brother side not implemented (FIXME)");
912 auto set_zero = [](
auto &nodes_data,
auto &nodes_dofs,
auto &field_entities) {
913 nodes_data.resize(0,
false);
914 nodes_dofs.resize(0,
false);
915 field_entities.resize(0,
false);
917 set_zero(master_nodes_data, master_nodes_dofs, master_field_entities);
918 set_zero(slave_nodes_data, slave_nodes_dofs, slave_field_entities);
923 auto bit_number = (*field_it)->getBitNumber();
924 const int nb_dofs_on_vert = (*field_it)->getNbOfCoeffs();
925 master_space = slave_space = (*field_it)->getSpace();
926 master_base = slave_base = (*field_it)->getApproxBase();
930 bit_number, get_id_for_min_type<MBVERTEX>());
931 auto lo = std::lower_bound(field_ents.begin(), field_ents.end(), lo_uid,
933 if (lo != field_ents.end()) {
935 bit_number, get_id_for_max_type<MBVERTEX>());
936 auto hi = std::upper_bound(lo, field_ents.end(), hi_uid,
cmp_uid_hi);
940 for (
auto it = lo; it != hi; ++it) {
941 if (
auto e = it->lock()) {
942 nb_dofs += e->getEntFieldData().size();
948 auto init_set = [&](
auto &nodes_data,
auto &nodes_dofs,
949 auto &field_entities) {
950 constexpr int num_nodes = 3;
951 const int max_nb_dofs = nb_dofs_on_vert * num_nodes;
952 nodes_data.resize(max_nb_dofs,
false);
953 nodes_dofs.resize(max_nb_dofs,
false);
954 field_entities.resize(num_nodes,
false);
956 fill(nodes_dofs.begin(), nodes_dofs.end(),
nullptr);
957 fill(field_entities.begin(), field_entities.end(),
nullptr);
960 init_set(master_nodes_data, master_nodes_dofs, master_field_entities);
961 init_set(slave_nodes_data, slave_nodes_dofs, slave_field_entities);
963 for (
auto it = lo; it != hi; ++it) {
964 if (
auto e = it->lock()) {
966 const auto &sn = e->getSideNumberPtr();
967 int side = sn->side_number;
969 auto set_data = [&](
auto &nodes_data,
auto &nodes_dofs,
970 auto &field_entities,
int side,
int pos) {
971 field_entities[side] = e.get();
972 if (
auto cache = e->entityCacheDataDofs.lock()) {
973 for (
auto dit =
cache->loHi[0]; dit !=
cache->loHi[1];
975 const auto dof_idx = (*dit)->getEntDofIdx();
976 nodes_data[pos + dof_idx] = (*dit)->getFieldData();
977 nodes_dofs[pos + dof_idx] =
984 set_data(master_nodes_data, master_nodes_dofs,
985 master_field_entities, side, side * nb_dofs_on_vert);
987 set_data(slave_nodes_data, slave_nodes_dofs,
988 slave_field_entities, (side - 3),
989 (side - 3) * nb_dofs_on_vert);
991 const int brother_side = sn->brother_side_number;
992 if (brother_side != -1)
994 "Not implemented (FIXME please)");
1005template <
typename EXTRACTOR>
1010 EXTRACTOR &&extractor)
const {
1013 auto clear_data = [type_lo, type_hi](
auto &data) {
1015 for (
auto &d : data.dataOnEntities[
t]) {
1016 d.getIndices().resize(0,
false);
1017 d.getLocalIndices().resize(0,
false);
1022 clear_data(master_data);
1023 clear_data(slave_data);
1028 auto lo = std::lower_bound(ents_field.begin(), ents_field.end(), lo_uid,
1030 if (lo != ents_field.end()) {
1033 auto hi = std::upper_bound(lo, ents_field.end(), hi_uid,
cmp_uid_hi);
1036 std::vector<boost::weak_ptr<FieldEntity>> brother_ents_vec;
1038 for (
auto it = lo; it != hi; ++it)
1039 if (
auto e = it->lock()) {
1042 const int side = e->getSideNumberPtr()->side_number;
1043 const int brother_side = e->getSideNumberPtr()->brother_side_number;
1044 if (brother_side != -1)
1046 "Not implemented case");
1048 auto get_indices = [&](
auto &data,
const auto type,
const auto side) {
1049 if (
auto cache = extractor(e).lock()) {
1050 for (
auto dit =
cache->loHi[0]; dit !=
cache->loHi[1]; ++dit) {
1051 auto &dof = (**dit);
1052 auto &dat = data.dataOnEntities[type][side];
1053 auto &ent_field_indices = dat.getIndices();
1054 auto &ent_field_local_indices = dat.getLocalIndices();
1055 if (ent_field_indices.empty()) {
1056 const int nb_dofs_on_ent = dof.getNbDofsOnEnt();
1057 ent_field_indices.resize(nb_dofs_on_ent,
false);
1058 ent_field_local_indices.resize(nb_dofs_on_ent,
false);
1059 std::fill(ent_field_indices.data().begin(),
1060 ent_field_indices.data().end(), -1);
1061 std::fill(ent_field_local_indices.data().begin(),
1062 ent_field_local_indices.data().end(), -1);
1064 const int idx = dof.getEntDofIdx();
1065 ent_field_indices[idx] = dof.getPetscGlobalDofIdx();
1066 ent_field_local_indices[idx] = dof.getPetscLocalDofIdx();
1075 get_indices(master_data, type, side);
1077 get_indices(slave_data, type, side - 6);
1083 get_indices(master_data, type, 0);
1085 get_indices(slave_data, type, 0);
1090 "Entity type not implemented");
1099template <
typename EXTRACTOR>
1104 EXTRACTOR &&extractor)
const {
1107 master_nodes_indices.resize(0,
false);
1108 master_local_nodes_indices.resize(0,
false);
1109 slave_nodes_indices.resize(0,
false);
1110 slave_local_nodes_indices.resize(0,
false);
1115 auto bit_number = (*field_it)->getBitNumber();
1116 const int nb_dofs_on_vert = (*field_it)->getNbOfCoeffs();
1119 bit_number, get_id_for_min_type<MBVERTEX>());
1120 auto lo = std::lower_bound(ents_field.begin(), ents_field.end(), lo_uid,
1122 if (lo != ents_field.end()) {
1124 bit_number, get_id_for_max_type<MBVERTEX>());
1125 auto hi = std::upper_bound(lo, ents_field.end(), hi_uid,
cmp_uid_hi);
1129 for (
auto it = lo; it != hi; ++it) {
1130 if (
auto e = it->lock()) {
1131 if (
auto cache = extractor(e).lock()) {
1132 nb_dofs += std::distance(
cache->loHi[0],
cache->loHi[1]);
1139 constexpr int num_nodes = 3;
1140 const int max_nb_dofs = nb_dofs_on_vert * num_nodes;
1142 auto set_vec_size = [&](
auto &nodes_indices,
1143 auto &local_nodes_indices) {
1144 nodes_indices.resize(max_nb_dofs,
false);
1145 local_nodes_indices.resize(max_nb_dofs,
false);
1146 std::fill(nodes_indices.begin(), nodes_indices.end(), -1);
1147 std::fill(local_nodes_indices.begin(), local_nodes_indices.end(),
1151 set_vec_size(master_nodes_indices, master_local_nodes_indices);
1152 set_vec_size(slave_nodes_indices, slave_local_nodes_indices);
1154 for (
auto it = lo; it != hi; ++it) {
1155 if (
auto e = it->lock()) {
1157 const int side = e->getSideNumberPtr()->side_number;
1158 const int brother_side =
1159 e->getSideNumberPtr()->brother_side_number;
1160 if (brother_side != -1)
1162 "Not implemented case");
1164 auto get_indices = [&](
auto &nodes_indices,
1165 auto &local_nodes_indices,
1167 if (
auto cache = extractor(e).lock()) {
1168 for (
auto dit =
cache->loHi[0]; dit !=
cache->loHi[1];
1170 const int idx = (*dit)->getPetscGlobalDofIdx();
1171 const int local_idx = (*dit)->getPetscLocalDofIdx();
1173 side * nb_dofs_on_vert + (*dit)->getDofCoeffIdx();
1174 nodes_indices[pos] = idx;
1175 local_nodes_indices[pos] = local_idx;
1181 get_indices(master_nodes_indices, master_local_nodes_indices,
1184 get_indices(slave_nodes_indices, slave_local_nodes_indices,
1200ContactPrismElementForcesAndSourcesCore::UserDataOperator::loopSideVolumes(
1201 const string fe_name,
1203 const int side_type,
const EntityHandle ent_for_side) {
1204 return loopSide(fe_name, &fe_method, side_type, ent_for_side);
#define CATCH_OP_ERRORS(OP)
FieldApproximationBase
approximation base
@ AINSWORTH_LEGENDRE_BASE
Ainsworth Cole (Legendre) approx. base .
#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
@ L2
field with C-1 continuity
@ LASTSPACE
FieldSpace in [ 0, LASTSPACE )
@ NOFIELD
scalar or vector of scalars describe (no true field)
@ HCURL
field with continuous tangents
@ HDIV
field with continuous normal traction
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
@ MOFEM_DATA_INCONSISTENCY
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
#define CHKERR
Inline error check.
FTensor::Index< 'n', SPACE_DIM > n
FTensor::Index< 'm', SPACE_DIM > m
virtual const Field * get_field_structure(const std::string &name, enum MoFEMTypes bh=MF_EXIST) const =0
get field structure
FTensor::Index< 'i', SPACE_DIM > i
const double v
phase velocity of light in medium (cm/ns)
FTensor::Index< 'j', 3 > j
FTensor::Index< 'k', 3 > k
constexpr std::enable_if<(Dim0<=2 &&Dim1<=2), Tensor2_Expr< Levi_Civita< T >, T, Dim0, Dim1, i, j > >::type levi_civita(const Index< i, Dim0 > &, const Index< j, Dim1 > &)
levi_civita functions to make for easy adhoc use
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
std::bitset< BITFIELDID_SIZE > BitFieldId
Field Id.
UBlasVector< int > VectorInt
implementation of Data Operators for Forces and Sources
static auto cmp_uid_lo(const boost::weak_ptr< FieldEntity > &a, const UId &b)
EntityHandle get_id_for_max_type()
static auto cmp_uid_hi(const UId &b, const boost::weak_ptr< FieldEntity > &a)
EntityHandle get_id_for_min_type()
ublas::vector< FieldEntity *, FieldEntAllocator > VectorFieldEntities
std::vector< boost::weak_ptr< FieldEntity > > FieldEntity_vector_view
Field_multiIndex::index< FieldName_mi_tag >::type::iterator field_it
ublas::vector< FEDofEntity *, DofsAllocator > VectorDofs
constexpr double t
plate stiffness
constexpr auto field_name
#define QUAD_2D_TABLE_SIZE
static QUAD *const QUAD_2D_TABLE[]
const Field_multiIndex * fieldsPtr
raw pointer to fields container
int getNinTheLoop() const
get number of evaluated element in the loop
virtual FieldBitNumber get_field_bit_number(const std::string name) const =0
get field bit number
virtual moab::Interface & get_moab()=0
virtual MoFEMErrorCode opRhs(EntitiesFieldData &data, const bool error_if_no_base=false)
Deprecated interface functions.
this class derive data form other data structure
Class used to pass element data to calculate base functions on tet,triangle,edge.
Data on single entity (This is passed as argument to DataOperator::doWork)
data structure for finite element entity
std::bitset< LASTSPACE > sPace
spaces on element
std::array< std::bitset< LASTSPACE >, MBMAXTYPE > spacesOnEntities
spaces on entity types
std::bitset< LASTBASE > bAse
bases on element
std::array< boost::ptr_vector< EntData >, MBMAXTYPE > dataOnEntities
std::array< std::bitset< LASTBASE >, LASTSPACE > basesOnSpaces
base on spaces
std::array< std::bitset< LASTBASE >, MBMAXTYPE > basesOnEntities
bases on entity types
keeps information about indexed dofs for the finite element
auto & getRowFieldEnts() const
auto getFEName() const
get finite element name
const FieldEntity_vector_view & getDataFieldEnts() const
boost::shared_ptr< const NumeredEntFiniteElement > numeredEntFiniteElementPtr
auto & getColFieldEnts() const
UId getLocalUniqueIdCalculate()
Get the Local Unique Id Calculate object.
Provide data structure for (tensor) field approximation.
FieldSpace getSpace() const
Get field approximation space.
const BitFieldId & getId() const
Get unique field id.
MultiIndex Tag for field name.
MoFEMErrorCode loopSide(const string &fe_name, ForcesAndSourcesCore *side_fe, const size_t dim, const EntityHandle ent_for_side=0, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy)
User call this function to loop over elements on the side of face. This function calls finite element...
structure to get information form mofem into EntitiesFieldData
int getMaxRowOrder() const
Get max order of approximation for field in rows.
auto & getUserPolynomialBase()
Get the User Polynomial Base object.
MoFEMErrorCode getSpacesAndBaseOnEntities(EntitiesFieldData &data) const
Get field approximation space and base on entities.
MoFEMErrorCode getNoFieldRowIndices(EntitiesFieldData &data, const int bit_number) const
get col NoField indices
virtual MoFEMErrorCode setGaussPts(int order_row, int order_col, int order_data)
set user specific integration rule
EntitiesFieldData & dataH1
virtual int getRule(int order_row, int order_col, int order_data)
another variant of getRule
boost::ptr_deque< UserDataOperator > opPtrVector
Vector of finite element users data operators.
const std::array< boost::shared_ptr< EntitiesFieldData >, LASTSPACE > dataOnElement
Entity data on element entity rows fields.
int getMaxColOrder() const
Get max order of approximation for field in columns.
MoFEMErrorCode getNoFieldColIndices(EntitiesFieldData &data, const int bit_number) const
get col NoField indices
int getMaxDataOrder() const
Get max order of approximation for data fields.
MoFEMErrorCode getNoFieldFieldData(const int bit_number, VectorDouble &ent_field_data, VectorDofs &ent_field_dofs, VectorFieldEntities &ent_field) const
Get field data on nodes.
MoFEMErrorCode createDataOnElement(EntityType type)
Create a entity data on element object.
Calculate base functions on triangle.