v0.14.0
Public Member Functions | Static Public Attributes | Protected Member Functions | Protected Attributes | Static Protected Attributes | List of all members
MoFEM::CoreTmp< 0 > Struct Reference

Core (interface) class. More...

#include <src/interfaces/Core.hpp>

Inheritance diagram for MoFEM::CoreTmp< 0 >:
[legend]
Collaboration diagram for MoFEM::CoreTmp< 0 >:
[legend]

Public Member Functions

const int getValue () const
 Get the core. More...
 
RefEntityTmp< 0 > getRefEntity (const EntityHandle ent)
 
virtual boost::shared_ptr< RefEntityTmp< 0 > > make_shared_ref_entity (const EntityHandle ent)
 Get RefEntity. More...
 
 CoreTmp (moab::Interface &moab, MPI_Comm comm=PETSC_COMM_WORLD, const int verbose=VERBOSE)
 
 ~CoreTmp ()
 
- Public Member Functions inherited from MoFEM::DeprecatedCoreInterface
virtual DEPRECATED MoFEMErrorCode seed_ref_level_2D (const EntityHandle meshset, const BitRefLevel &bit, int verb=-1)
 seed 2D entities (Triangles entities only) in the meshset and their adjacencies (only TRIs adjacencies) in a particular BitRefLevel More...
 
DEPRECATED MoFEMErrorCode seed_ref_level_3D (const EntityHandle meshset, const BitRefLevel &bit, int verb=-1)
 seed 2D entities in the meshset and their adjacencies (only TETs adjacencies) in a particular BitRefLevel More...
 
DEPRECATED MoFEMErrorCode seed_ref_level (const Range &ents, const BitRefLevel &bit, const bool only_tets=true, int verb=-1)
 seed entities in the range and their adjacencies in a particular BitRefLevel More...
 
DEPRECATED MoFEMErrorCode partition_mesh (const Range &ents, const int dim, const int adj_dim, const int n_parts, int verb=-1)
 Set partition tag to each finite element in the problem. More...
 
DEPRECATED MoFEMErrorCode synchronise_entities (Range &ent, int verb=DEFAULT_VERBOSITY)
 
DEPRECATED MoFEMErrorCode synchronise_field_entities (const std::string &name, int verb=DEFAULT_VERBOSITY)
 
- Public Member Functions inherited from MoFEM::CoreInterface
virtual ~CoreInterface ()=default
 
- Public Member Functions inherited from MoFEM::UnknownInterface
template<class IFACE >
MoFEMErrorCode registerInterface (bool error_if_registration_failed=true)
 Register interface. More...
 
template<class IFACE >
MoFEMErrorCode getInterface (IFACE *&iface) const
 Get interface reference to pointer of interface. More...
 
template<class IFACE >
MoFEMErrorCode getInterface (IFACE **const iface) const
 Get interface pointer to pointer of interface. More...
 
template<class IFACE , typename boost::enable_if< boost::is_pointer< IFACE >, int >::type = 0>
IFACE getInterface () const
 Get interface pointer to pointer of interface. More...
 
template<class IFACE , typename boost::enable_if< boost::is_reference< IFACE >, int >::type = 0>
IFACE getInterface () const
 Get reference to interface. More...
 
template<class IFACE >
IFACE * getInterface () const
 Function returning pointer to interface. More...
 
virtual ~UnknownInterface ()=default
 

Static Public Attributes

static constexpr int value = 0
 

Protected Member Functions

template<int V>
 CoreTmp (moab::Interface &moab, MPI_Comm comm, const int verbose, CoreValue< V >)
 
MoFEMErrorCode coreGenericConstructor (moab::Interface &moab, MPI_Comm comm, const int verbose)
 
MoFEMErrorCode addProblem (const BitProblemId id, const std::string &name, int verb=DEFAULT_VERBOSITY)
 add problem More...
 
MoFEMErrorCode getTags (int verb=DEFAULT_VERBOSITY)
 Get tag handles. More...
 
MoFEMErrorCode clearMap ()
 Cleaning database. More...
 
MoFEMErrorCode registerSubInterfaces ()
 Register insterfaces. More...
 
BitProblemId getProblemShift ()
 Return unique problem Id. More...
 
MoFEMErrorCode initialiseDatabaseFromMesh (int verb=DEFAULT_VERBOSITY)
 Initialize database getting information on mesh. More...
 
MoFEMErrorCode getOptions (int verb=DEFAULT_VERBOSITY)
 Get core options from command line. More...
 
template<class IFACE >
MoFEMErrorCode regSubInterface ()
 Register sub-interfaces in core interface. More...
 
template<class IFACE >
MoFEMErrorCode regEvents ()
 Register petsc events. More...
 

Protected Attributes

boost::shared_ptr< WrapMPICommwrapMPIMOABComm
 manage creation and destruction of MOAB communicator More...
 
int verbose
 Verbosity level. More...
 
boost::ptr_map< boost::typeindex::type_index, UnknownInterfaceiFaces
 Hash map of pointers to interfaces. More...
 
int * buildMoFEM
 keeps flags/semaphores for different stages More...
 
std::string optionsPrefix
 Prefix for options on command line. More...
 
PetscBool initaliseAndBuildField
 
PetscBool initaliseAndBuildFiniteElements
 

Static Protected Attributes

static bool isGloballyInitialised = false
 Core base globally initialized. More...
 
static int mpiInitialised
 mpi was initialised by other agent More...
 
static PetscBool isInitialized
 petsc was initialised by other agent More...
 

Global initialisation and finalisation


static MoFEMErrorCode Initialize (int *argc, char ***args, const char file[], const char help[])
 Initializes the MoFEM database PETSc, MOAB and MPI. More...
 
static MoFEMErrorCode Finalize ()
 Checks for options to be called at the conclusion of the program. More...
 

Static functions

static void setRefEntBasicDataPtr (MoFEM::Interface &m_field, boost::shared_ptr< BasicEntityData > &ptr)
 
static boost::shared_ptr< RefEntityTmp< 0 > > makeSharedRefEntity (MoFEM::Interface &m_field, const EntityHandle ent)
 

Assessing interfaces

MoFEMErrorCode query_interface (boost::typeindex::type_index type_index, UnknownInterface **iface) const
 Getting interface of core database. More...
 

Get tag handles to data on the mesh

Tag get_th_RefParentHandle () const
 
Tag get_th_RefBitLevel () const
 
Tag get_th_RefBitEdge () const
 

Auxiliary data and functions

enum  SemaphoresBuildMofem {
  BUILD_FIELD = 1 << 0, BUILD_FE = 1 << 1, BUILD_ADJ = 1 << 2, BUILD_PROBLEM = 1 << 3,
  PARTITION_PROBLEM = 1 << 4, PARTITION_FE = 1 << 5, PARTITION_GHOST_DOFS = 1 << 6, PARTITION_MESH = 1 << 7
}
 
int & getBuildMoFEM () const
 Get flags/semaphores for different stages. More...
 
MoFEMErrorCode addPrismToDatabase (const EntityHandle prism, int verb=DEFAULT_VERBOSITY)
 add prim element More...
 

Tags to data on mesh and entities

Tag th_Part
 Tag for partition number. More...
 
Tag th_RefParentHandle
 
Tag th_RefBitLevel
 
Tag th_RefBitLevel_Mask
 
Tag th_RefBitEdge
 
Tag th_RefFEMeshset
 
Tag th_FieldId
 
Tag th_FieldName
 
Tag th_FieldName_DataNamePrefix
 
Tag th_FieldSpace
 
Tag th_FieldContinuity
 
Tag th_FieldBase
 
Tag th_FEId
 
Tag th_FEName
 
Tag th_FEIdCol
 
Tag th_FEIdRow
 
Tag th_FEIdData
 
Tag th_ProblemId
 
Tag th_ProblemName
 
Tag th_ProblemFEId
 
Tag th_ProblemNbDofsRow
 
Tag th_ProblemNbDofsCol
 
Tag th_ProblemLocalNbDofRow
 
Tag th_ProblemGhostNbDofRow
 
Tag th_ProblemLocalNbDofCol
 
Tag th_ProblemGhostNbDofCol
 
Tag th_ProblemShift
 
Tag th_ElemType
 Needed for VTK files. More...
 
Tag th_MoFEMBuild
 
boost::shared_ptr< BasicEntityDatabasicEntityDataPtr
 
boost::shared_ptr< BasicEntityData > & get_basic_entity_data_ptr ()
 Get pointer to basic entity data. More...
 

Multi-Indices accessing data on the mesh

RefEntity_multiIndex refinedEntities
 refined entities More...
 
RefElement_multiIndex refinedFiniteElements
 refined elements More...
 
Field_multiIndex fIelds
 fields More...
 
FieldEntity_multiIndex entsFields
 entities on fields More...
 
DofEntity_multiIndex dofsField
 dofs on fields More...
 
FiniteElement_multiIndex finiteElements
 finite elements More...
 
EntFiniteElement_multiIndex entsFiniteElements
 finite element entities More...
 
FieldEntityEntFiniteElementAdjacencyMap_multiIndex entFEAdjacencies
 adjacencies of elements to dofs More...
 
Problem_multiIndex pRoblems
 problems multi-index More...
 

Get moab database

std::reference_wrapper< moab::Interface > moab
 moab database More...
 
moab::Interface & get_moab ()
 
const moab::Interface & get_moab () const
 
MoFEMErrorCode set_moab_interface (moab::Interface &new_moab, int verb=VERBOSE)
 Set the moab interface object. More...
 
MoFEMErrorCode setMoabInterface (moab::Interface &new_moab, int verb=VERBOSE)
 

Check database consistency

MoFEMErrorCode check_number_of_ents_in_ents_field (const std::string &name) const
 check data consistency in entitiesPtr More...
 
MoFEMErrorCode check_number_of_ents_in_ents_field () const
 check data consistency in entitiesPtr More...
 
MoFEMErrorCode check_number_of_ents_in_ents_finite_element (const std::string &name) const
 check data consistency in entsFiniteElements More...
 
MoFEMErrorCode check_number_of_ents_in_ents_finite_element () const
 check data consistency in entsFiniteElements More...
 

Clear database

MoFEMErrorCode clear_database (int verb=DEFAULT_VERBOSITY)
 Clear database. More...
 
MoFEMErrorCode rebuild_database (int verb=DEFAULT_VERBOSITY)
 Clear database and initialize it once again. More...
 

Getting access to meshset manager

MeshsetsManagerget_meshsets_manager_ptr ()
 get MeshsetsManager pointer More...
 
const MeshsetsManagerget_meshsets_manager_ptr () const
 get MeshsetsManager pointer More...
 
MeshsetsManagerget_meshsets_manager ()
 get MeshsetsManager pointer More...
 
const MeshsetsManagerget_meshsets_manager () const
 get MeshsetsManager pointer More...
 

Remove and delete entities

MoFEMErrorCode remove_parents_by_ents (const Range &ents, int verb=DEFAULT_VERBOSITY)
 Remove parents from entities. More...
 
MoFEMErrorCode remove_parents_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 Remove parent from entities on bit level. More...
 
MoFEMErrorCode remove_parents_by_parents (const Range &ents, int verb=DEFAULT_VERBOSITY)
 Remove paremts from entities having parents in passed range. More...
 
MoFEMErrorCode remove_ents (const Range ents, int verb=DEFAULT_VERBOSITY)
 remove entities form mofem database More...
 
MoFEMErrorCode remove_ents_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 remove entities form mofem database More...
 
MoFEMErrorCode delete_ents_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, const bool remove_parent=false, int verb=DEFAULT_VERBOSITY, MoFEMTypes mf=MF_ZERO)
 delete entities form mofem and moab database More...
 

Fields

virtual MoFEMErrorCode add_broken_field (const std::string &name, const FieldSpace space, const FieldApproximationBase base, const FieldCoefficientsNumber nb_coefficients, const TagType tag_type=MB_TAG_SPARSE, const enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)
 Add filed. More...
 
virtual MoFEMErrorCode add_field (const std::string &name, const FieldSpace space, const FieldApproximationBase base, const FieldCoefficientsNumber nb_coefficients, const TagType tag_type=MB_TAG_SPARSE, const enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)
 Add filed. More...
 
MoFEMErrorCode delete_field (const std::string name, int verb=DEFAULT_VERBOSITY)
 Delete field. More...
 
MoFEMErrorCode addField (const std::string &name, const FieldSpace space, const FieldContinuity continuity, const FieldApproximationBase base, const FieldCoefficientsNumber nb_coefficients, const TagType tag_type, const enum MoFEMTypes bh, int verb)
 Template for add_field. More...
 
MoFEMErrorCode addEntsToFieldByDim (const Range &ents, const int dim, const std::string &name, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode add_ents_to_field_by_dim (const Range &ents, const int dim, const std::string &name, int verb=DEFAULT_VERBOSITY)
 Add entities to field meshset. More...
 
MoFEMErrorCode add_ents_to_field_by_type (const Range &ents, const EntityType type, const std::string &name, int verb=DEFAULT_VERBOSITY)
 Add entities to field meshset. More...
 
MoFEMErrorCode add_ents_to_field_by_dim (const EntityHandle meshset, const int dim, const std::string &name, const bool recursive=true, int verb=DEFAULT_VERBOSITY)
 Add entities to field meshset. More...
 
MoFEMErrorCode add_ents_to_field_by_type (const EntityHandle meshset, const EntityType type, const std::string &name, const bool recursive=true, int verb=DEFAULT_VERBOSITY)
 Add entities to field meshset. More...
 
MoFEMErrorCode create_vertices_and_add_to_field (const std::string name, const double coords[], int size, int verb=DEFAULT_VERBOSITY)
 Create a vertices and add to field object. More...
 

Set approximation order

MoFEMErrorCode setFieldOrder (const Range &ents, const BitFieldId id, const ApproximationOrder order, int ver)
 
MoFEMErrorCode setFieldOrderImpl (boost::shared_ptr< Field > field_ptr, const Range &ents, const ApproximationOrder order, int verb)
 
MoFEMErrorCode set_field_order (const Range &ents, const BitFieldId id, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode set_field_order (const EntityHandle meshset, const EntityType type, const BitFieldId id, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode set_field_order (const Range &ents, const std::string &name, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)
 Set order approximation of the entities in the field. More...
 
MoFEMErrorCode set_field_order (const EntityHandle meshset, const EntityType type, const std::string &name, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)
 Set order approximation of the entities in the field. More...
 
MoFEMErrorCode set_field_order_by_entity_type_and_bit_ref (const BitRefLevel &bit, const BitRefLevel &mask, const EntityType type, const BitFieldId id, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode set_field_order_by_entity_type_and_bit_ref (const BitRefLevel &bit, const BitRefLevel &mask, const EntityType type, const std::string &name, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)
 Set order approximation of the entities in the field. More...
 

Build fields

MoFEMErrorCode buildFieldForNoFieldImpl (boost::shared_ptr< Field > field_ptr, std::map< EntityType, int > &dof_counter, int verb)
 
MoFEMErrorCode buildFieldForNoField (const BitFieldId id, std::map< EntityType, int > &dof_counter, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode buildFieldForL2H1HcurlHdiv (const BitFieldId id, std::map< EntityType, int > &dof_counter, std::map< EntityType, int > &inactive_dof_counter, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode buildField (const boost::shared_ptr< Field > &field, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode build_fields (int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode build_field (const std::string field_name, int verb=DEFAULT_VERBOSITY)
 build field by name More...
 

Clear DOFs

MoFEMErrorCode clear_inactive_dofs (int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_dofs_fields_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_dofs_fields (const Range ents, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_dofs_fields (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)
 

Clear ENTs

MoFEMErrorCode clear_ents_fields_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_ents_fields (const Range ents, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_ents_fields (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)
 

Remove field entities

MoFEMErrorCode remove_ents_from_field_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 remove entities from field More...
 
MoFEMErrorCode remove_ents_from_field (const std::string name, const EntityHandle meshset, const EntityType type, int verb=DEFAULT_VERBOSITY)
 remove entities from field More...
 
MoFEMErrorCode remove_ents_from_field (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)
 remove entities from field More...
 
MoFEMErrorCode remove_ents_from_field (const Range ents, int verb=DEFAULT_VERBOSITY)
 remove entities from all fields More...
 

Other auxiliary functions for fields

MoFEMErrorCode list_dofs_by_field_name (const std::string &name) const
 
MoFEMErrorCode list_fields () const
 list entities in the field More...
 
BitFieldId get_field_id (const std::string &name) const
 Get field Id. More...
 
FieldBitNumber get_field_bit_number (const std::string name) const
 get field bit number More...
 
std::string get_field_name (const BitFieldId id) const
 get field name from id More...
 
EntityHandle get_field_meshset (const BitFieldId id) const
 
EntityHandle get_field_meshset (const std::string name) const
 get field meshset More...
 
MoFEMErrorCode get_field_entities_by_dimension (const std::string name, int dim, Range &ents) const
 get entities in the field by dimension More...
 
MoFEMErrorCode get_field_entities_by_type (const std::string name, EntityType type, Range &ents) const
 get entities in the field by type More...
 
MoFEMErrorCode get_field_entities_by_handle (const std::string name, Range &ents) const
 get entities in the field by handle More...
 
bool check_field (const std::string &name) const
 check if field is in database More...
 
const Fieldget_field_structure (const std::string &name, enum MoFEMTypes bh=MF_EXIST) const
 get field structure More...
 

Finite elements

const FiniteElementget_finite_element_structure (const std::string &name, enum MoFEMTypes bh=MF_EXCL) const
 get finite element struture More...
 
bool check_finite_element (const std::string &name) const
 Check if finite element is in database. More...
 
MoFEMErrorCode add_finite_element (const std::string &fe_name, enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)
 add finite element More...
 
MoFEMErrorCode modify_finite_element_adjacency_table (const std::string &fe_name, const EntityType type, ElementAdjacencyFunct function)
 modify finite element table, only for advanced user More...
 
MoFEMErrorCode modify_finite_element_add_field_data (const std::string &fe_name, const std::string name_filed)
 set finite element field data More...
 
MoFEMErrorCode modify_finite_element_add_field_row (const std::string &fe_name, const std::string name_row)
 set field row which finite element use More...
 
MoFEMErrorCode modify_finite_element_add_field_col (const std::string &fe_name, const std::string name_col)
 set field col which finite element use More...
 
MoFEMErrorCode modify_finite_element_off_field_data (const std::string &fe_name, const std::string name_filed)
 unset finite element field data More...
 
MoFEMErrorCode modify_finite_element_off_field_row (const std::string &fe_name, const std::string name_row)
 unset field row which finite element use More...
 
MoFEMErrorCode modify_finite_element_off_field_col (const std::string &fe_name, const std::string name_col)
 unset field col which finite element use More...
 
MoFEMErrorCode add_ents_to_finite_element_by_type (const EntityHandle meshset, const EntityType type, const std::string &name, const bool recursive=true)
 add entities to finite element More...
 
MoFEMErrorCode add_ents_to_finite_element_by_dim (const EntityHandle meshset, const int dim, const std::string &name, const bool recursive=true)
 add entities to finite element More...
 
MoFEMErrorCode add_ents_to_finite_element_by_type (const Range &ents, const EntityType type, const std::string &name)
 add entities to finite elements More...
 
MoFEMErrorCode add_ents_to_finite_element_by_dim (const Range &ents, const int dim, const std::string &name)
 add entities to finite elements More...
 
MoFEMErrorCode add_ents_to_finite_element_by_bit_ref (const BitRefLevel &bit, const BitRefLevel &mask, const std::string &name, EntityType type, int verb=DEFAULT_VERBOSITY)
 add TET entities from given refinement level to finite element database given by name More...
 
MoFEMErrorCode add_ents_to_finite_element_by_MESHSET (const EntityHandle meshset, const std::string &name, const bool recursive=false)
 add MESHSET element to finite element database given by name More...
 
DEPRECATED MoFEMErrorCode add_ents_to_finite_element_EntType_by_bit_ref (const BitRefLevel &bit, const std::string &name, EntityType type, int verb=DEFAULT_VERBOSITY)
 
DEPRECATED MoFEMErrorCode add_ents_to_finite_element_EntType_by_bit_ref (const BitRefLevel &bit, const BitRefLevel &mask, const std::string &name, EntityType type, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode remove_ents_from_finite_element_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 remove elements from given refinement level to finite element database More...
 
MoFEMErrorCode remove_ents_from_finite_element (const std::string name, const EntityHandle meshset, const EntityType type, int verb=DEFAULT_VERBOSITY)
 remove entities from given refinement level to finite element database More...
 
MoFEMErrorCode remove_ents_from_finite_element (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)
 remove entities from finite element database More...
 
MoFEMErrorCode remove_ents_from_finite_element (const Range ents, int verb=DEFAULT_VERBOSITY)
 remove entities from finite elements in database More...
 
MoFEMErrorCode delete_finite_element (const std::string name, int verb=DEFAULT_VERBOSITY)
 delete finite element from mofem database More...
 
BitFEId getBitFEId (const std::string &fe_name) const
 Get field Id. More...
 
std::string getBitFEIdName (const BitFEId id) const
 Get field name. More...
 
EntityHandle get_finite_element_meshset (const BitFEId id) const
 
EntityHandle get_finite_element_meshset (const std::string name) const
 
MoFEMErrorCode get_finite_element_entities_by_dimension (const std::string name, int dim, Range &ents) const
 get entities in the finite element by dimension More...
 
MoFEMErrorCode get_finite_element_entities_by_type (const std::string name, EntityType type, Range &ents) const
 get entities in the finite element by type More...
 
MoFEMErrorCode get_finite_element_entities_by_handle (const std::string name, Range &ents) const
 get entities in the finite element by handle More...
 
MoFEMErrorCode list_finite_elements () const
 list finite elements in database More...
 

Problems

MoFEMErrorCode add_problem (const std::string &name, enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)
 Add problem. More...
 
bool check_problem (const std::string name)
 check if problem exist More...
 
MoFEMErrorCode delete_problem (const std::string name)
 Delete problem. More...
 
MoFEMErrorCode modify_problem_add_finite_element (const std::string name_problem, const std::string &fe_name)
 add finite element to problem, this add entities assigned to finite element to a particular problem More...
 
MoFEMErrorCode modify_problem_unset_finite_element (const std::string name_problem, const std::string &fe_name)
 unset finite element from problem, this remove entities assigned to finite element to a particular problem More...
 
MoFEMErrorCode modify_problem_ref_level_add_bit (const std::string &name_problem, const BitRefLevel &bit)
 add ref level to problem More...
 
MoFEMErrorCode modify_problem_ref_level_set_bit (const std::string &name_problem, const BitRefLevel &bit)
 set ref level for problem More...
 
MoFEMErrorCode modify_problem_mask_ref_level_add_bit (const std::string &name_problem, const BitRefLevel &bit)
 set dof mask ref level for problem More...
 
MoFEMErrorCode modify_problem_mask_ref_level_set_bit (const std::string &name_problem, const BitRefLevel &bit)
 set dof mask ref level for problem More...
 
BitProblemId getBitProblemId (const std::string &name) const
 
MoFEMErrorCode list_problem () const
 list problems More...
 
MoFEMErrorCode clear_problem (const std::string name, int verb=DEFAULT_VERBOSITY)
 clear problem More...
 
MoFEMErrorCode clear_problems (int verb=DEFAULT_VERBOSITY)
 clear problems More...
 
MoFEMErrorCode build_finite_elements (int verb=DEFAULT_VERBOSITY)
 Build finite elements. More...
 
MoFEMErrorCode build_finite_elements (const BitRefLevel &bit, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode build_finite_elements (const string fe_name, const Range *const ents_ptr=nullptr, int verb=DEFAULT_VERBOSITY)
 Build finite elements. More...
 
MoFEMErrorCode buildFiniteElements (const boost::shared_ptr< FiniteElement > &fe, const Range *ents_ptr=NULL, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_finite_elements_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_finite_elements (const Range &ents, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_finite_elements (const std::string &fe_name, const Range &ents, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode get_problem_finite_elements_entities (const std::string name, const std::string &fe_name, const EntityHandle meshset)
 add finite elements to the meshset More...
 
DEPRECATED MoFEMErrorCode build_problem_on_distributed_mesh (int verb=DEFAULT_VERBOSITY)
 
DEPRECATED MoFEMErrorCode build_problems (int verb=DEFAULT_VERBOSITY)
 

Adjacencies

MoFEMErrorCode build_adjacencies (const Range &ents, int verb=DEFAULT_VERBOSITY)
 build adjacencies More...
 
MoFEMErrorCode build_adjacencies (const BitRefLevel &bit, int verb=DEFAULT_VERBOSITY)
 build adjacencies More...
 
MoFEMErrorCode build_adjacencies (const BitRefLevel &bit, const BitRefLevel &mask, int verb=DEFAULT_VERBOSITY)
 build adjacencies More...
 
MoFEMErrorCode clear_adjacencies_entities (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 clear adjacency map for entities on given bit level More...
 
MoFEMErrorCode clear_adjacencies_entities (const Range ents, int verb=DEFAULT_VERBOSITY)
 clear adjacencies for field entities by entities More...
 
MoFEMErrorCode clear_adjacencies_entities (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)
 clear adjacencies for field entities by entities and field namd More...
 
MoFEMErrorCode clear_adjacencies_finite_elements (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
 clear adjacency map for finite elements on given bit level More...
 
MoFEMErrorCode clear_adjacencies_finite_elements (const Range ents, int verb=DEFAULT_VERBOSITY)
 
MoFEMErrorCode clear_adjacencies_finite_elements (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)
 

Methods for preforming operations on elements

MoFEMErrorCode problem_basic_method_preProcess (const Problem *problem_ptr, BasicMethod &method, int verb=DEFAULT_VERBOSITY)
 Set data for BasicMethod. More...
 
MoFEMErrorCode problem_basic_method_preProcess (const std::string &problem_name, BasicMethod &method, int verb=DEFAULT_VERBOSITY)
 Set data for BasicMethod. More...
 
MoFEMErrorCode problem_basic_method_postProcess (const Problem *problem_ptr, BasicMethod &method, int verb=DEFAULT_VERBOSITY)
 Set data for BasicMethod. More...
 
MoFEMErrorCode problem_basic_method_postProcess (const std::string &problem_name, BasicMethod &method, int verb=DEFAULT_VERBOSITY)
 Set data for BasicMethod. More...
 
MoFEMErrorCode cache_problem_entities (const std::string prb_name, CacheTupleWeakPtr cache_ptr)
 Cache variables. More...
 
MoFEMErrorCode loop_finite_elements (const Problem *problem_ptr, const std::string &fe_name, FEMethod &method, int lower_rank, int upper_rank, boost::shared_ptr< NumeredEntFiniteElement_multiIndex > fe_ptr=nullptr, MoFEMTypes bh=MF_EXIST, CacheTupleWeakPtr cache_ptr=CacheTupleSharedPtr(), int verb=DEFAULT_VERBOSITY)
 Make a loop over finite elements on partitions from upper to lower rank. More...
 
MoFEMErrorCode loop_finite_elements (const std::string problem_name, const std::string &fe_name, FEMethod &method, int lower_rank, int upper_rank, boost::shared_ptr< NumeredEntFiniteElement_multiIndex > fe_ptr=nullptr, MoFEMTypes bh=MF_EXIST, CacheTupleWeakPtr cache_ptr=CacheTupleSharedPtr(), int verb=DEFAULT_VERBOSITY)
 Make a loop over finite elements on partitions from upper to lower rank. More...
 
MoFEMErrorCode loop_finite_elements (const std::string problem_name, const std::string &fe_name, FEMethod &method, boost::shared_ptr< NumeredEntFiniteElement_multiIndex > fe_ptr=nullptr, MoFEMTypes bh=MF_EXIST, CacheTupleWeakPtr cache_ptr=CacheTupleSharedPtr(), int verb=DEFAULT_VERBOSITY)
 Make a loop over finite elements. More...
 
MoFEMErrorCode loop_dofs (const Problem *problem_ptr, const std::string &field_name, RowColData rc, DofMethod &method, int lower_rank, int upper_rank, int verb=DEFAULT_VERBOSITY)
 Make a loop over dofs. More...
 
MoFEMErrorCode loop_dofs (const std::string &problem_name, const std::string &field_name, RowColData rc, DofMethod &method, int lower_rank, int upper_rank, int verb=DEFAULT_VERBOSITY)
 Make a loop over dofs. More...
 
MoFEMErrorCode loop_dofs (const std::string &problem_name, const std::string &field_name, RowColData rc, DofMethod &method, int verb=DEFAULT_VERBOSITY)
 Make a loop over dofs. More...
 
MoFEMErrorCode loop_dofs (const std::string &field_name, DofMethod &method, int verb=DEFAULT_VERBOSITY)
 Make a loop over dofs. More...
 
MoFEMErrorCode loop_entities (const Problem *problem_ptr, const std::string field_name, RowColData rc, EntityMethod &method, int lower_rank, int upper_rank, int verb=DEFAULT_VERBOSITY)
 Loop over field entities in the problem. More...
 
MoFEMErrorCode loop_entities (const std::string problem_name, const std::string field_name, RowColData rc, EntityMethod &method, int lower_rank, int upper_rank, int verb=DEFAULT_VERBOSITY)
 Loop over field entities in the problem. More...
 
MoFEMErrorCode loop_entities (const std::string problem_name, const std::string field_name, RowColData rc, EntityMethod &method, int verb=DEFAULT_VERBOSITY)
 Loop over field entities in the problem. More...
 
MoFEMErrorCode loop_entities (const std::string field_name, EntityMethod &method, Range const *const ents=nullptr, int verb=DEFAULT_VERBOSITY)
 Loop over field entities. More...
 

Accessing multi-indices

MoFEMErrorCode get_fields (const Field_multiIndex **fields_ptr) const
 Get fields multi-index from database. More...
 
MoFEMErrorCode get_ref_ents (const RefEntity_multiIndex **refined_entities_ptr) const
 Get ref entities multi-index from database. More...
 
MoFEMErrorCode get_ref_finite_elements (const RefElement_multiIndex **refined_finite_elements_ptr) const
 Get ref finite elements multi-index form database. More...
 
MoFEMErrorCode get_finite_elements (const FiniteElement_multiIndex **fe_ptr) const
 Get finite elements multi-index. More...
 
MoFEMErrorCode get_ents_finite_elements (const EntFiniteElement_multiIndex **fe_ent_ptr) const
 Get entities finite elements multi-index. More...
 
MoFEMErrorCode get_field_ents (const FieldEntity_multiIndex **field_ents) const
 Get field multi index. More...
 
MoFEMErrorCode get_dofs (const DofEntity_multiIndex **dofs_ptr) const
 Get dofs multi index. More...
 
MoFEMErrorCode get_problem (const std::string &problem_name, const Problem **problem_ptr) const
 Get problem database (data structure) More...
 
MoFEMErrorCode get_problems (const Problem_multiIndex **problems_ptr) const
 Get pointer to problems multi-index. More...
 
MoFEMErrorCode get_ents_elements_adjacency (const FieldEntityEntFiniteElementAdjacencyMap_multiIndex **dofs_elements_adjacency) const
 Get the dofs elements adjacency object. More...
 
const Field_multiIndexget_fields () const
 Get the fields object. More...
 
const RefEntity_multiIndexget_ref_ents () const
 Get the ref ents object. More...
 
const RefElement_multiIndexget_ref_finite_elements () const
 Get the ref finite elements object. More...
 
const FiniteElement_multiIndexget_finite_elements () const
 Get the finite elements object. More...
 
const EntFiniteElement_multiIndexget_ents_finite_elements () const
 Get the ents finite elements object. More...
 
const FieldEntity_multiIndexget_field_ents () const
 Get the field ents object. More...
 
const DofEntity_multiIndexget_dofs () const
 Get the dofs object. More...
 
const Problemget_problem (const std::string problem_name) const
 Get the problem object. More...
 
const Problem_multiIndexget_problems () const
 Get the problems object. More...
 
const FieldEntityEntFiniteElementAdjacencyMap_multiIndexget_ents_elements_adjacency () const
 Get the dofs elements adjacency object. More...
 
FieldEntityByUId::iterator get_ent_field_by_name_begin (const std::string &field_name) const
 get begin iterator of filed ents of given name (instead you can use IT_GET_ENT_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT) More...
 
FieldEntityByUId::iterator get_ent_field_by_name_end (const std::string &field_name) const
 get begin iterator of filed dofs of given name (instead you can use IT_GET_ENT_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT) More...
 
DofEntityByUId::iterator get_dofs_by_name_begin (const std::string &field_name) const
 get begin iterator of filed dofs of given name (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT) More...
 
DofEntityByUId::iterator get_dofs_by_name_end (const std::string &field_name) const
 get begin iterator of filed dofs of given name (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT) More...
 
DofEntityByUId::iterator get_dofs_by_name_and_ent_begin (const std::string &field_name, const EntityHandle ent) const
 get begin iterator of filed dofs of given name and ent(instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,ENT,IT) More...
 
DofEntityByUId::iterator get_dofs_by_name_and_ent_end (const std::string &field_name, const EntityHandle ent) const
 get begin iterator of filed dofs of given name and ent (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,ENT,IT) More...
 
DofEntityByUId::iterator get_dofs_by_name_and_type_begin (const std::string &field_name, const EntityType type) const
 get begin iterator of filed dofs of given name and ent type (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,TYPE,IT) More...
 
DofEntityByUId::iterator get_dofs_by_name_and_type_end (const std::string &field_name, const EntityType ent) const
 get begin iterator of filed dofs of given name end ent type(instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,TYPE,IT) More...
 
EntFiniteElement_multiIndex::index< Unique_mi_tag >::type::iterator get_fe_by_name_begin (const std::string &fe_name) const
 get begin iterator of finite elements of given name (instead you can use IT_GET_FES_BY_NAME_FOR_LOOP(MFIELD,NAME,IT) More...
 
EntFiniteElement_multiIndex::index< Unique_mi_tag >::type::iterator get_fe_by_name_end (const std::string &fe_name) const
 get end iterator of finite elements of given name (instead you can use IT_GET_FES_BY_NAME_FOR_LOOP(MFIELD,NAME,IT) More...
 

Log events

PetscLogEvent MOFEM_EVENT_preProcess
 Event for preProcess finite element. More...
 
PetscLogEvent MOFEM_EVENT_operator
 Event for evaluating operator of finite element. More...
 
PetscLogEvent MOFEM_EVENT_postProcess
 Event for postProcess finite element. More...
 
PetscLogEvent MOFEM_EVENT_createMat
 

Communicator

MPI_Comm mofemComm
 MoFEM communicator. More...
 
ParallelComm * pComm
 MOAB communicator structure. More...
 
int sIze
 MoFEM communicator size. More...
 
int rAnk
 MOFEM communicator rank. More...
 
MPI_Comm & get_comm () const
 
int get_comm_size () const
 
int get_comm_rank () const
 

Additional Inherited Members

- Static Public Member Functions inherited from MoFEM::UnknownInterface
static MoFEMErrorCode getLibVersion (Version &version)
 Get library version. More...
 
static MoFEMErrorCode getFileVersion (moab::Interface &moab, Version &version)
 Get database major version. More...
 
static MoFEMErrorCode setFileVersion (moab::Interface &moab, Version version=Version(MoFEM_VERSION_MAJOR, MoFEM_VERSION_MINOR, MoFEM_VERSION_BUILD))
 Get database major version. More...
 
static MoFEMErrorCode getInterfaceVersion (Version &version)
 Get database major version. More...
 

Detailed Description

Core (interface) class.

This is the implementation of abstract MoFEM::Interface class. Similarly to the convention used in MoAB, we use small letters to name function of purely abstract classes. This is an exception used only here. For more details about naming functions see Coding practice

This class is not used directly by the user. For internal use only. It is database with basic functions to access data. Abstraction of this is MoFEM Interface structure.

Such deign to hide complexities for users and allow low development without interfering with users modules programmer work.

Todo:
Implement static functions for Initialization and Finalization of MoFEM. Those functions should keep all static variables and initialize/finalize other libs like PETSc. Moreover initialization functions should set error handlers, etc.
Examples
add_blockset.cpp, add_cubit_meshsets.cpp, adolc_plasticity.cpp, analytical_nonlinear_poisson.cpp, analytical_poisson.cpp, analytical_poisson_field_split.cpp, approx_sphere.cpp, bernstein_bezier_generate_base.cpp, bone_adaptation.cpp, boundary_marker.cpp, build_large_problem.cpp, build_problems.cpp, cell_forces.cpp, child_and_parent.cpp, continuity_check_on_contact_prism_side_ele.cpp, continuity_check_on_skeleton_3d.cpp, continuity_check_on_skeleton_with_simple_2d_for_h1.cpp, continuity_check_on_skeleton_with_simple_2d_for_hcurl.cpp, continuity_check_on_skeleton_with_simple_2d_for_hdiv.cpp, cubit_bc_test.cpp, delete_ho_nodes.cpp, dg_projection.cpp, dm_build_partitioned_mesh.cpp, dm_create_subdm.cpp, dm_partitioned_no_field.cpp, dynamic_first_order_con_law.cpp, edge_and_bubble_shape_functions_on_quad.cpp, eigen_elastic.cpp, elasticity.cpp, elasticity_mixed_formulation.cpp, ep.cpp, field_evaluator.cpp, field_to_vertices.cpp, forces_and_sources_testing_edge_element.cpp, forces_and_sources_testing_flat_prism_element.cpp, forces_and_sources_testing_users_base.cpp, free_surface.cpp, gauss_points_on_outer_product.cpp, hanging_node_approx.cpp, hcurl_check_approx_in_2d.cpp, hcurl_curl_operator.cpp, hcurl_divergence_operator_2d.cpp, hdiv_divergence_operator.cpp, heat_equation.cpp, heat_method.cpp, hello_world.cpp, helmholtz.cpp, hertz_surface.cpp, higher_derivatives.cpp, level_set.cpp, log.cpp, loop_entities.cpp, lorentz_force.cpp, magnetostatic.cpp, mesh_cut.cpp, mesh_insert_interface_atom.cpp, mesh_smoothing.cpp, meshset_to_vtk.cpp, minimal_surface_area.cpp, mixed_poisson.cpp, mortar_contact.cpp, mortar_contact_thermal.cpp, navier_stokes.cpp, node_merge.cpp, nonlinear_dynamics.cpp, nonlinear_elastic.cpp, operators_tests.cpp, partition_mesh.cpp, phase.cpp, photon_diffusion.cpp, plastic.cpp, plate.cpp, plot_base.cpp, poisson_2d_dis_galerkin.cpp, poisson_2d_homogeneous.cpp, prism_elements_from_surface.cpp, prism_polynomial_approximation.cpp, quad_polynomial_approximation.cpp, reaction_diffusion.cpp, remove_entities_from_problem.cpp, remove_entities_from_problem_not_partitioned.cpp, scalar_check_approximation.cpp, schur_test_diag_mat.cpp, seepage.cpp, shallow_wave.cpp, simple_contact.cpp, simple_contact_thermal.cpp, simple_elasticity.cpp, simple_interface.cpp, simple_l2_only.cpp, split_sideset.cpp, tensor_divergence_operator.cpp, test_broken_space.cpp, test_cache_on_entities.cpp, test_jacobian_of_simple_contact_element.cpp, testing_jacobian_of_hook_element.cpp, testing_jacobian_of_hook_scaled_with_density_element.cpp, thermo_elastic.cpp, unsaturated_transport.cpp, wave_equation.cpp, and wavy_surface.cpp.

Definition at line 82 of file Core.hpp.

Member Enumeration Documentation

◆ SemaphoresBuildMofem

Is used to check consistency. I n future properly this will be removed and replaced by other solution. It is only for internal use.

Enumerator
BUILD_FIELD 
BUILD_FE 
BUILD_ADJ 
BUILD_PROBLEM 
PARTITION_PROBLEM 
PARTITION_FE 
PARTITION_GHOST_DOFS 
PARTITION_MESH 

Definition at line 211 of file Core.hpp.

211  {
212  BUILD_FIELD = 1 << 0,
213  BUILD_FE = 1 << 1,
214  BUILD_ADJ = 1 << 2,
215  BUILD_PROBLEM = 1 << 3,
216  PARTITION_PROBLEM = 1 << 4,
217  PARTITION_FE = 1 << 5,
218  PARTITION_GHOST_DOFS = 1 << 6,
219  PARTITION_MESH = 1 << 7
220  };

Constructor & Destructor Documentation

◆ CoreTmp() [1/2]

MoFEM::Core::CoreTmp ( moab::Interface &  moab,
MPI_Comm  comm = PETSC_COMM_WORLD,
const int  verbose = VERBOSE 
)

Construct core database

Parameters
moabMoAB interface
commMPI communicator
verboseVerbosity level

Definition at line 235 of file Core.cpp.

240  : CoreTmp(moab, comm, verbose, CoreValue<0>()) {
241 
242  // Register sub-interfaces
243  ierr = this->registerSubInterfaces();
244  CHKERRABORT(comm, ierr);
245  ierr = this->clearMap();
246  CHKERRABORT(comm, ierr);
247  ierr = this->getTags();
248  CHKERRABORT(comm, ierr);
249  ierr = this->getOptions(verbose);
250  CHKERRABORT(comm, ierr);
251 
252  this->basicEntityDataPtr = boost::make_shared<BasicEntityData>(moab);
254 
256  CHKERRABORT(comm, ierr);
257 }

◆ ~CoreTmp()

MoFEM::Core::~CoreTmp ( )

Definition at line 283 of file Core.cpp.

283  {
284  PetscBool is_finalized;
285  PetscFinalized(&is_finalized);
286  // Destroy interfaces
287  iFaces.clear();
288  // This is deprecated ONE should use MoFEM::Core::Initialize
289  if (isGloballyInitialised && is_finalized) {
290  isGloballyInitialised = false;
291  }
292 }

◆ CoreTmp() [2/2]

template<int V>
MoFEM::CoreTmp< 0 >::CoreTmp ( moab::Interface &  moab,
MPI_Comm  comm,
const int  verbose,
CoreValue< V >   
)
protected

Construct core database

Parameters
moabMoAB interface
commMPI communicator

Definition at line 32 of file CoreTemplates.hpp.

34  : moab(moab), mofemComm(comm), verbose(verbose),
35  initaliseAndBuildField(PETSC_FALSE),
36  initaliseAndBuildFiniteElements(PETSC_FALSE) {
37 
39  CHKERRABORT(comm, ierr);
40 
41  MOFEM_LOG_CHANNEL("WORLD");
42  if (verbose > QUIET) {
43  MOFEM_LOG_C("WORLD", Sev::verbose, "Core number < %d >", V);
44  }
45 }

Member Function Documentation

◆ add_broken_field()

MoFEMErrorCode MoFEM::Core::add_broken_field ( const std::string &  name,
const FieldSpace  space,
const FieldApproximationBase  base,
const FieldCoefficientsNumber  nb_coefficients,
const TagType  tag_type = MB_TAG_SPARSE,
const enum MoFEMTypes  bh = MF_EXCL,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Add filed.

Parameters
nameField name
spaceSpace L2,H1,Hdiv,Hcurl
continuityField continuity (you can set broken space)
baseApproximation base AINSWORTH_LEGENDRE_BASE, AINSWORTH_BERNSTEIN_BEZIER_BASE ...
nb_coefficientsNumber of field coefficients
tag_typeTag type, MB_TAG_DENSE or MB_TAG_SPARSE (default)
bhControl behavior, if MF_EXCL throws error if exist
verbVerbosity level
Returns
Return error code

TODO:

Todo:
MB_TAG_DENSE will not work properly in general case. It is need to separate field tags for each entity separately. That will allow for HO orders but homogenous approx. order on each entity. Need some discussion what is optimal solution. MB_TAG_SPARSE gives flexibility, but it not memory efficient. MB_TAG_DENSE uses memory more efficient and in principle allow for better efficiency if properly utilized.

FIXME:

Bug:
Need to resolve problem of dense tags at this stage of development will make only problems

Implements MoFEM::CoreInterface.

Definition at line 282 of file FieldCore.cpp.

286  {
287  return this->addField(name, space, DISCONTINUOUS, base, nb_of_coefficients,
288  tag_type, bh, verb);
289 }

◆ add_ents_to_field_by_dim() [1/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_field_by_dim ( const EntityHandle  meshset,
const int  dim,
const std::string &  name,
const bool  recursive = true,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Add entities to field meshset.

\not collective

The lower dimension entities are added depending on the space type

Parameters
meshset
dimdimension
namename of field
recursivetake entities recursively from embedded entities
verbverbosity level
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 416 of file FieldCore.cpp.

419  {
421  Range ents;
422  CHKERR get_moab().get_entities_by_dimension(meshset, dim, ents, recursive);
423  CHKERR addEntsToFieldByDim(ents, dim, name, verb);
426 }

◆ add_ents_to_field_by_dim() [2/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_field_by_dim ( const Range ents,
const int  dim,
const std::string &  name,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Add entities to field meshset.

Note
not collective

The lower dimension entities are added depending on the space type

Parameters
entsrange of entities
dimdimension of entities
namename of field
verbverbosity level
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 392 of file FieldCore.cpp.

394  {
396  Range ents_dim = ents.subset_by_dimension(dim);
397  CHKERR addEntsToFieldByDim(ents_dim, dim, name, verb);
400 }

◆ add_ents_to_field_by_type() [1/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_field_by_type ( const EntityHandle  meshset,
const EntityType  type,
const std::string &  name,
const bool  recursive = true,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Add entities to field meshset.

Note
not collective

The lower dimension entities are added depending on the space type

Parameters
meshset
typeof entities
namename of field
recursivetake entities recursively from embedded entities
verbverbosity level
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 428 of file FieldCore.cpp.

431  {
433  Range ents;
434  CHKERR get_moab().get_entities_by_type(meshset, type, ents, recursive);
435  if (!ents.empty()) {
436  const int dim = get_moab().dimension_from_handle(ents[0]);
437  CHKERR addEntsToFieldByDim(ents, dim, name, verb);
438  }
441 }

◆ add_ents_to_field_by_type() [2/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_field_by_type ( const Range ents,
const EntityType  type,
const std::string &  name,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Add entities to field meshset.

Note
not collective

The lower dimension entities are added depending on the space type

Parameters
entsrange of entities
typetype of entities
namename of field
verbverbosity level
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 402 of file FieldCore.cpp.

405  {
407  Range ents_type = ents.subset_by_type(type);
408  if (!ents_type.empty()) {
409  const int dim = get_moab().dimension_from_handle(ents_type[0]);
410  CHKERR addEntsToFieldByDim(ents_type, dim, name, verb);
411  }
414 }

◆ add_ents_to_finite_element_by_bit_ref()

MoFEMErrorCode MoFEM::Core::add_ents_to_finite_element_by_bit_ref ( const BitRefLevel bit,
const BitRefLevel mask,
const std::string &  name,
EntityType  type,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

add TET entities from given refinement level to finite element database given by name

Note
not collective
Parameters
BitRefLevelbit
BitRefLevelmask
finiteelement name
finiteelement type
verboselevel

Implements MoFEM::CoreInterface.

Definition at line 405 of file FECore.cpp.

407  {
409 
410  if (verb == -1)
411  verb = verbose;
412  *buildMoFEM &= 1 << 0;
413  const BitFEId id = getBitFEId(name);
415 
416  auto &ref_MoFEMFiniteElement = refinedFiniteElements.get<Ent_mi_tag>();
417  auto miit = ref_MoFEMFiniteElement.lower_bound(get_id_for_min_type(type));
418  auto hi_miit = ref_MoFEMFiniteElement.upper_bound(get_id_for_max_type(type));
419 
420  int nb_add_fes = 0;
421  for (; miit != hi_miit; miit++) {
422  const auto &bit2 = miit->get()->getBitRefLevel();
423  if ((bit2 & mask) != bit2)
424  continue;
425  if ((bit2 & bit).any()) {
426  EntityHandle ent = miit->get()->getEnt();
427  CHKERR get_moab().add_entities(idm, &ent, 1);
428  nb_add_fes++;
429  }
430  }
431 
432  MOFEM_LOG("SYNC", Sev::inform)
433  << "Finite element " << name << " added. Nb. of elements added "
434  << nb_add_fes << " out of " << std::distance(miit, hi_miit);
435 
437 
439 }

◆ add_ents_to_finite_element_by_dim() [1/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_finite_element_by_dim ( const EntityHandle  entities,
const int  dim,
const std::string &  name,
const bool  recursive = true 
)
protectedvirtual

add entities to finite element

Note
not collective
Parameters
entitiesmeshset or range form were entities taken
dimdimension
namename of field
recursivetake entities from meshsets in meshset
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 346 of file FECore.cpp.

348  {
349  EntityHandle idm = no_handle;
350  *buildMoFEM &= 1 << 0;
353  Range ents;
354  CHKERR get_moab().get_entities_by_dimension(meshset, dim, ents, recursive);
355  CHKERR getInterface<BitRefManager>()->setElementsBitRefLevel(ents);
356  CHKERR get_moab().add_entities(idm, ents);
358 }

◆ add_ents_to_finite_element_by_dim() [2/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_finite_element_by_dim ( const Range ents,
const int  dim,
const std::string &  name 
)
protectedvirtual

add entities to finite elements

Note
not collective
Parameters
entsrange of entities
dimdimension of entities
namename of finite element
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 373 of file FECore.cpp.

374  {
375  EntityHandle idm = no_handle;
376  *buildMoFEM &= 1 << 0;
379  CHKERR getInterface<BitRefManager>()->setElementsBitRefLevel(
380  ents.subset_by_dimension(dim));
381  CHKERR get_moab().add_entities(idm, ents.subset_by_dimension(dim));
383 }

◆ add_ents_to_finite_element_by_MESHSET()

MoFEMErrorCode MoFEM::Core::add_ents_to_finite_element_by_MESHSET ( const EntityHandle  meshset,
const std::string &  name,
const bool  recursive = false 
)
protectedvirtual

add MESHSET element to finite element database given by name

Note
not collective
Parameters
meshsetcontains all entities that could be used for finite element
nameFinite Element name

Implements MoFEM::CoreInterface.

Definition at line 441 of file FECore.cpp.

442  {
444  *buildMoFEM &= 1 << 0;
445  const BitFEId id = getBitFEId(name);
447  if (recursive == false) {
448  CHKERR get_moab().add_entities(idm, &meshset, 1);
449  } else {
450  Range meshsets;
451  CHKERR get_moab().get_entities_by_type(meshset, MBENTITYSET, meshsets,
452  false);
453  CHKERR get_moab().add_entities(idm, meshsets);
454  }
456 }

◆ add_ents_to_finite_element_by_type() [1/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_finite_element_by_type ( const EntityHandle  entities,
const EntityType  type,
const std::string &  name,
const bool  recursive = true 
)
protectedvirtual

add entities to finite element

Note
not collective
Parameters
entitiesmeshset or range form were entities taken
typetype of entity
namename of field
recursivetake entities from meshsets in meshset
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 329 of file FECore.cpp.

331  {
332  *buildMoFEM &= 1 << 0;
333  EntityHandle idm = no_handle;
335 
337  Range ents;
338  CHKERR get_moab().get_entities_by_type(meshset, type, ents, recursive);
339  CHKERR getInterface<BitRefManager>()->setElementsBitRefLevel(ents);
340  CHKERR get_moab().add_entities(idm, ents);
341 
343 }

◆ add_ents_to_finite_element_by_type() [2/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_finite_element_by_type ( const Range ents,
const EntityType  type,
const std::string &  name 
)
protectedvirtual

add entities to finite elements

Note
not collective
Parameters
entsrange of entities
typetype of entity (MBVERTEX, MBEDGE, MBTRI, ...)
namename of finite element
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 360 of file FECore.cpp.

361  {
362  EntityHandle idm = no_handle;
363  *buildMoFEM &= 1 << 0;
366  CHKERR getInterface<BitRefManager>()->setElementsBitRefLevel(
367  ents.subset_by_type(type));
368  CHKERR get_moab().add_entities(idm, ents.subset_by_type(type));
370 } // namespace MoFEM

◆ add_ents_to_finite_element_EntType_by_bit_ref() [1/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_finite_element_EntType_by_bit_ref ( const BitRefLevel bit,
const BitRefLevel mask,
const std::string &  name,
EntityType  type,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 396 of file FECore.cpp.

398  {
401 
403 }

◆ add_ents_to_finite_element_EntType_by_bit_ref() [2/2]

MoFEMErrorCode MoFEM::Core::add_ents_to_finite_element_EntType_by_bit_ref ( const BitRefLevel bit,
const std::string &  name,
EntityType  type,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 386 of file FECore.cpp.

388  {
391  type, verb);
392 
394 }

◆ add_field()

MoFEMErrorCode MoFEM::Core::add_field ( const std::string &  name,
const FieldSpace  space,
const FieldApproximationBase  base,
const FieldCoefficientsNumber  nb_coefficients,
const TagType  tag_type = MB_TAG_SPARSE,
const enum MoFEMTypes  bh = MF_EXCL,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Add filed.

Parameters
nameField name
spaceSpace L2,H1,Hdiv,Hcurl
continuityField continuity (you can set broken space)
baseApproximation base AINSWORTH_LEGENDRE_BASE, AINSWORTH_BERNSTEIN_BEZIER_BASE ...
nb_coefficientsNumber of field coefficients
tag_typeTag type, MB_TAG_DENSE or MB_TAG_SPARSE (default)
bhControl behavior, if MF_EXCL throws error if exist
verbVerbosity level
Returns
Return error code

TODO:

Todo:
MB_TAG_DENSE will not work properly in general case. It is need to separate field tags for each entity separately. That will allow for HO orders but homogenous approx. order on each entity. Need some discussion what is optimal solution. MB_TAG_SPARSE gives flexibility, but it not memory efficient. MB_TAG_DENSE uses memory more efficient and in principle allow for better efficiency if properly utilized.

FIXME:

Bug:
Need to resolve problem of dense tags at this stage of development will make only problems

Implements MoFEM::CoreInterface.

Definition at line 291 of file FieldCore.cpp.

295  {
296  return this->addField(name, space, CONTINUOUS, base, nb_of_coefficients,
297  tag_type, bh, verb);
298 }

◆ add_finite_element()

MoFEMErrorCode MoFEM::Core::add_finite_element ( const std::string &  fe_name,
enum MoFEMTypes  bh = MF_EXCL,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

add finite element

Parameters
namefinite element name
Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.

Example

CHKERR mField.add_finite_element("ELASTIC");
CHKERR mField.add_finite_element("PLASTIC");

Implements MoFEM::CoreInterface.

Definition at line 43 of file FECore.cpp.

44  {
46  *buildMoFEM &= 1 << 0;
47  if (verb == -1) {
48  verb = verbose;
49  }
50 
51  // Add finite element meshset to partion meshset. In case of no elements
52  // on processor part, when mesh file is read, finite element meshset is
53  // prevented from deletion by moab reader.
54  auto add_meshset_to_partition = [&](auto meshset) {
56  const void *tag_vals[] = {&rAnk};
57  ParallelComm *pcomm = ParallelComm::get_pcomm(
58  &get_moab(), get_basic_entity_data_ptr()->pcommID);
59  Tag part_tag = pcomm->part_tag();
60  Range tagged_sets;
61  CHKERR get_moab().get_entities_by_type_and_tag(0, MBENTITYSET, &part_tag,
62  tag_vals, 1, tagged_sets,
63  moab::Interface::UNION);
64  for (auto s : tagged_sets)
65  CHKERR get_moab().add_entities(s, &meshset, 1);
67  };
68 
69  auto &finite_element_name_set =
70  finiteElements.get<FiniteElement_name_mi_tag>();
71  auto it_fe = finite_element_name_set.find(fe_name);
72 
73  if (bh == MF_EXCL) {
74  if (it_fe != finite_element_name_set.end()) {
75  SETERRQ1(mofemComm, MOFEM_NOT_FOUND, "this < %s > is there",
76  fe_name.c_str());
77  }
78 
79  } else {
80  if (it_fe != finite_element_name_set.end())
82  }
83  EntityHandle meshset;
84  CHKERR get_moab().create_meshset(MESHSET_SET, meshset);
85  CHKERR add_meshset_to_partition(meshset);
86 
87  // id
88  int fe_shift = 0;
89  for (; finiteElements.get<BitFEId_mi_tag>().find(BitFEId().set(fe_shift)) !=
90  finiteElements.get<BitFEId_mi_tag>().end();
91  ++fe_shift) {
92  }
93 
94  auto id = BitFEId().set(fe_shift);
95  CHKERR get_moab().tag_set_data(th_FEId, &meshset, 1, &id);
96 
97  // id name
98  void const *tag_data[] = {fe_name.c_str()};
99  int tag_sizes[1];
100  tag_sizes[0] = fe_name.size();
101  CHKERR get_moab().tag_set_by_ptr(th_FEName, &meshset, 1, tag_data, tag_sizes);
102 
103  // add FiniteElement
104  auto p = finiteElements.insert(
105  boost::shared_ptr<FiniteElement>(new FiniteElement(moab, meshset)));
106  if (!p.second)
108  "FiniteElement not inserted");
109 
110  if (verb > QUIET)
111  MOFEM_LOG("WORLD", Sev::inform) << "Add finite element " << fe_name;
112 
114 }

◆ add_problem()

MoFEMErrorCode MoFEM::Core::add_problem ( const std::string &  name,
enum MoFEMTypes  bh = MF_EXCL,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Add problem.

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.

Implements MoFEM::CoreInterface.

Definition at line 84 of file ProblemsCore.cpp.

85  {
87  if (verb == -1)
88  verb = verbose;
89  auto miit = pRoblems.get<Problem_mi_tag>().find(name);
90  if (miit == pRoblems.get<Problem_mi_tag>().end()) {
91 
92  int p_shift = 0;
93  for (; pRoblems.get<BitProblemId_mi_tag>().find(BitProblemId().set(
94  p_shift)) != pRoblems.get<BitProblemId_mi_tag>().end();
95  ++p_shift) {
96  }
97 
98  auto id = BitProblemId().set(p_shift);
99  CHKERR addProblem(id, name, verb);
100 
101  } else if (bh == MF_EXCL) {
102  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "problem is in database %s",
103  name.c_str());
104  }
106 }

◆ addEntsToFieldByDim()

MoFEMErrorCode MoFEM::Core::addEntsToFieldByDim ( const Range ents,
const int  dim,
const std::string &  name,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 300 of file FieldCore.cpp.

301  {
302 
303  *buildMoFEM = 0;
304  EntityHandle idm = no_handle;
305  if (verb == -1)
306  verb = verbose;
307 
308  MOFEM_LOG_CHANNEL("SYNC");
309  MOFEM_LOG_TAG("SYNC", "FieldCore");
311 
313  idm = get_field_meshset(name);
314  FieldSpace space;
315  CHKERR get_moab().tag_get_data(th_FieldSpace, &idm, 1, &space);
316  FieldContinuity continuity;
317  CHKERR get_moab().tag_get_data(th_FieldContinuity, &idm, 1, &continuity);
318 
319  switch (continuity) {
320  case CONTINUOUS:
321  case DISCONTINUOUS:
322  break;
323  default:
324  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
325  "sorry, unknown continuity added to entity");
326  }
327 
328  std::vector<int> nb_ents_on_dim(3, 0);
329  switch (space) {
330  case L2:
331  CHKERR get_moab().add_entities(idm, ents);
332  break;
333  case H1:
334  CHKERR get_moab().add_entities(idm, ents);
335  if (continuity == DISCONTINUOUS)
336  break;
337  for (int dd = 0; dd != dim; ++dd) {
338  Range adj_ents;
339  CHKERR get_moab().get_adjacencies(ents, dd, false, adj_ents,
340  moab::Interface::UNION);
341  if (dd == 0) {
342  Range topo_nodes;
343  CHKERR get_moab().get_connectivity(ents, topo_nodes, true);
344  Range mid_nodes;
345  CHKERR get_moab().get_connectivity(ents, mid_nodes, false);
346  mid_nodes = subtract(mid_nodes, topo_nodes);
347  adj_ents = subtract(adj_ents, mid_nodes);
348  }
349  CHKERR get_moab().add_entities(idm, adj_ents);
350  nb_ents_on_dim[dd] = adj_ents.size();
351  }
352  break;
353  case HCURL:
354  CHKERR get_moab().add_entities(idm, ents);
355  if (continuity == DISCONTINUOUS)
356  break;
357  for (int dd = 1; dd != dim; ++dd) {
358  Range adj_ents;
359  CHKERR get_moab().get_adjacencies(ents, dd, false, adj_ents,
360  moab::Interface::UNION);
361  CHKERR get_moab().add_entities(idm, adj_ents);
362  nb_ents_on_dim[dd] = adj_ents.size();
363  }
364  break;
365  case HDIV:
366  CHKERR get_moab().add_entities(idm, ents);
367  if (continuity == DISCONTINUOUS)
368  break;
369  if (dim > 2) {
370  Range adj_ents;
371  CHKERR get_moab().get_adjacencies(ents, 2, false, adj_ents,
372  moab::Interface::UNION);
373  CHKERR get_moab().add_entities(idm, adj_ents);
374  nb_ents_on_dim[2] = adj_ents.size();
375  }
376  break;
377  default:
378  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
379  "sorry, unknown space added to entity");
380  }
381 
382  if (verb >= VERBOSE) {
383  MOFEM_LOG("SYNC", Sev::noisy) << "add entities to field " << name;
384  MOFEM_LOG("SYNC", Sev::noisy) << "\tnb. add ents " << ents.size();
385  MOFEM_LOG("SYNC", Sev::noisy) << "\tnb. add faces " << nb_ents_on_dim[2];
386  MOFEM_LOG("SYNC", Sev::noisy) << "\tnb. add edges " << nb_ents_on_dim[1];
387  MOFEM_LOG("SYNC", Sev::noisy) << "\tnb. add nodes " << nb_ents_on_dim[0];
388  }
390 }

◆ addField()

MoFEMErrorCode MoFEM::Core::addField ( const std::string &  name,
const FieldSpace  space,
const FieldContinuity  continuity,
const FieldApproximationBase  base,
const FieldCoefficientsNumber  nb_coefficients,
const TagType  tag_type,
const enum MoFEMTypes  bh,
int  verb 
)
protected

Template for add_field.

Template Parameters
CoreN
Parameters
name
space@parma continuity
base
nb_coefficients
tag_type
bh
verb
Returns
MoFEMErrorCode

Definition at line 108 of file FieldCore.cpp.

113  {
114  MOFEM_LOG_CHANNEL("WORLD");
115  MOFEM_LOG_TAG("WORLD", "FieldCore");
116  MOFEM_LOG_CHANNEL("SYNC");
117  MOFEM_LOG_TAG("SYNC", "FieldCore");
120 
121  // Add field mesh set to partion meshset. In case of no elements
122  // on processor part, when mesh file is read, finite element meshset is
123  // prevented from deletion by moab reader.
124  auto add_meshset_to_partition = [&](auto meshset) {
126  const void *tag_vals[] = {&rAnk};
127  ParallelComm *pcomm = ParallelComm::get_pcomm(
128  &get_moab(), get_basic_entity_data_ptr()->pcommID);
129  Tag part_tag = pcomm->part_tag();
130  Range tagged_sets;
131  CHKERR get_moab().get_entities_by_type_and_tag(0, MBENTITYSET, &part_tag,
132  tag_vals, 1, tagged_sets,
133  moab::Interface::UNION);
134  for (auto s : tagged_sets)
135  CHKERR get_moab().add_entities(s, &meshset, 1);
137  };
138 
139  auto create_tags = [&](auto meshset, auto id) {
141  CHKERR get_moab().tag_set_data(th_FieldId, &meshset, 1, &id);
142  // space
143  CHKERR get_moab().tag_set_data(th_FieldSpace, &meshset, 1, &space);
144  // continuity
145  CHKERR get_moab().tag_set_data(th_FieldContinuity, &meshset, 1,
146  &continuity);
147  // base
148  CHKERR get_moab().tag_set_data(th_FieldBase, &meshset, 1, &base);
149 
150  // name
151  void const *tag_data[] = {name.c_str()};
152  int tag_sizes[1];
153  tag_sizes[0] = name.size();
154  CHKERR get_moab().tag_set_by_ptr(th_FieldName, &meshset, 1, tag_data,
155  tag_sizes);
156  // rank
157  Tag th_rank;
158  int def_rank = 1;
159  const std::string tag_rank_name = "_Field_Rank_" + name;
160  CHKERR get_moab().tag_get_handle(tag_rank_name.c_str(), 1, MB_TYPE_INTEGER,
161  th_rank, MB_TAG_CREAT | MB_TAG_SPARSE,
162  &def_rank);
163  CHKERR get_moab().tag_set_data(th_rank, &meshset, 1, &nb_of_coefficients);
164 
165  Version file_ver;
167  CHK_THROW_MESSAGE(ierr, "Not known file version");
168  if (file_ver.majorVersion >= 0 && file_ver.minorVersion >= 12 &&
169  file_ver.buildVersion >= 1) {
170  const std::string name_data_prefix("_App_Data_");
171  void const *tag_prefix_data[] = {name_data_prefix.c_str()};
172  int tag_prefix_sizes[1];
173  tag_prefix_sizes[0] = name_data_prefix.size();
174  CHKERR get_moab().tag_set_by_ptr(th_FieldName_DataNamePrefix, &meshset, 1,
175  tag_prefix_data, tag_prefix_sizes);
176  Tag th_app_order, th_field_data, th_field_data_vert;
177 
178  // order
179  ApproximationOrder def_approx_order = -1;
180  const std::string tag_approx_order_name = "_App_Order_" + name;
181  CHKERR get_moab().tag_get_handle(
182  tag_approx_order_name.c_str(), 1, MB_TYPE_INTEGER, th_app_order,
183  MB_TAG_CREAT | MB_TAG_SPARSE, &def_approx_order);
184 
185  // data
186  std::string tag_data_name = name_data_prefix + name;
187  const int def_len = 0;
188  CHKERR get_moab().tag_get_handle(
189  tag_data_name.c_str(), def_len, MB_TYPE_DOUBLE, th_field_data,
190  MB_TAG_CREAT | MB_TAG_VARLEN | MB_TAG_SPARSE, NULL);
191  std::string tag_data_name_verts = name_data_prefix + name + "_V";
192  VectorDouble def_vert_data(nb_of_coefficients);
193  def_vert_data.clear();
194  CHKERR get_moab().tag_get_handle(
195  tag_data_name_verts.c_str(), nb_of_coefficients, MB_TYPE_DOUBLE,
196  th_field_data_vert, MB_TAG_CREAT | tag_type, &*def_vert_data.begin());
197  } else {
198  // Deprecated names
199  const std::string name_data_prefix("_App_Data");
200  void const *tag_prefix_data[] = {name_data_prefix.c_str()};
201  int tag_prefix_sizes[1];
202  tag_prefix_sizes[0] = name_data_prefix.size();
203  CHKERR get_moab().tag_set_by_ptr(th_FieldName_DataNamePrefix, &meshset, 1,
204  tag_prefix_data, tag_prefix_sizes);
205  Tag th_app_order, th_field_data, th_field_data_vert;
206 
207  // order
208  ApproximationOrder def_approx_order = -1;
209  const std::string tag_approx_order_name = "_App_Order_" + name;
210  CHKERR get_moab().tag_get_handle(
211  tag_approx_order_name.c_str(), 1, MB_TYPE_INTEGER, th_app_order,
212  MB_TAG_CREAT | MB_TAG_SPARSE, &def_approx_order);
213 
214  // data
215  std::string tag_data_name = name_data_prefix + name;
216  const int def_len = 0;
217  CHKERR get_moab().tag_get_handle(
218  tag_data_name.c_str(), def_len, MB_TYPE_DOUBLE, th_field_data,
219  MB_TAG_CREAT | MB_TAG_VARLEN | MB_TAG_SPARSE, NULL);
220  std::string tag_data_name_verts = name_data_prefix + name + "V";
221  VectorDouble def_vert_data(nb_of_coefficients);
222  def_vert_data.clear();
223  CHKERR get_moab().tag_get_handle(
224  tag_data_name_verts.c_str(), nb_of_coefficients, MB_TYPE_DOUBLE,
225  th_field_data_vert, MB_TAG_CREAT | tag_type, &*def_vert_data.begin());
226  }
227 
229  };
230 
231  if (verb == -1)
232  verb = verbose;
233  *buildMoFEM = 0;
234  auto fit = fIelds.get<FieldName_mi_tag>().find(name);
235  if (fit != fIelds.get<FieldName_mi_tag>().end()) {
236  if (bh == MF_EXCL)
237  SETERRQ1(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
238  "field is <%s> in database", name.c_str());
239 
240  } else {
241 
242  EntityHandle meshset;
243  CHKERR get_moab().create_meshset(MESHSET_SET, meshset);
244  CHKERR add_meshset_to_partition(meshset);
245 
246  // id
247  int field_shift = 0;
248  for (;
249  fIelds.get<BitFieldId_mi_tag>().find(BitFieldId().set(field_shift)) !=
250  fIelds.get<BitFieldId_mi_tag>().end();
251  ++field_shift) {
252  if (field_shift == BITFEID_SIZE)
253  SETERRQ(PETSC_COMM_SELF, MOFEM_IMPOSSIBLE_CASE,
254  "Maximal number of fields exceeded");
255  }
256 
257  auto id = BitFieldId().set(field_shift);
258  CHKERR create_tags(meshset, id);
259 
260  auto p = fIelds.insert(boost::make_shared<Field>(moab, meshset));
261  if (verb > QUIET) {
262  MOFEM_LOG("WORLD", Sev::inform) << "Add field " << **p.first;
263  MOFEM_LOG("WORLD", Sev::noisy)
264  << "Field " << (*p.first)->getName() << " core value < "
265  << this->getValue() << " > field value ( "
266  << static_cast<int>((*p.first)->getBitNumber()) << " )";
267  }
268 
269  if (!p.second)
270  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND,
271  "field not inserted %s (top tip, it could be already "
272  "there)",
273  Field(moab, meshset).getName().c_str());
274  }
275 
276  MOFEM_LOG_CHANNEL("WORLD");
277  MOFEM_LOG_CHANNEL("SYNC");
279 }

◆ addPrismToDatabase()

MoFEMErrorCode MoFEM::Core::addPrismToDatabase ( const EntityHandle  prism,
int  verb = DEFAULT_VERBOSITY 
)

add prim element

FIXME: This is dirt solution, need to be fixed

Parameters
prismprim handle
verbverbosity level
Returns
error code

Definition at line 522 of file Core.cpp.

522  {
524  if (verb == -1)
525  verb = verbose;
526  std::pair<RefEntity_multiIndex::iterator, bool> p_ent;
527  p_ent = refinedEntities.insert(
528  boost::make_shared<RefEntity>(basicEntityDataPtr, prism));
529  if (p_ent.second) {
530  std::pair<RefElement_multiIndex::iterator, bool> p;
531  p = refinedFiniteElements.insert(
532  boost::shared_ptr<RefElement>(new RefElement_PRISM(*p_ent.first)));
533  int num_nodes;
534  const EntityHandle *conn;
535  CHKERR get_moab().get_connectivity(prism, conn, num_nodes, true);
536  Range face_side3, face_side4;
537  CHKERR get_moab().get_adjacencies(conn, 3, 2, false, face_side3);
538  CHKERR get_moab().get_adjacencies(&conn[3], 3, 2, false, face_side4);
539  if (face_side3.size() != 1)
540  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
541  "prism don't have side face 3");
542  if (face_side4.size() != 1)
543  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
544  "prims don't have side face 4");
545  p.first->get()->getSideNumberPtr(*face_side3.begin());
546  p.first->get()->getSideNumberPtr(*face_side4.begin());
547  }
549 }

◆ addProblem()

MoFEMErrorCode MoFEM::Core::addProblem ( const BitProblemId  id,
const std::string &  name,
int  verb = DEFAULT_VERBOSITY 
)
protected

add problem

Parameters
idproblem id
nameproblem name
verbverbosity level
Returns
MoFEMErrorCode

Definition at line 27 of file ProblemsCore.cpp.

28  {
30 
31  if (verb == -1)
32  verb = verbose;
33  EntityHandle meshset;
34  CHKERR get_moab().create_meshset(MESHSET_SET, meshset);
35  CHKERR get_moab().tag_set_data(th_ProblemId, &meshset, 1, &id);
36 
37  // Add problem meshset to partion meshset. In case of no elements
38  // on processor part, when mesh file is read, finite element meshset is
39  // prevented from deletion by moab reader.
40  auto add_meshset_to_partition = [&](auto meshset) {
42  const void *tag_vals[] = {&rAnk};
43  ParallelComm *pcomm = ParallelComm::get_pcomm(
44  &get_moab(), get_basic_entity_data_ptr()->pcommID);
45  Tag part_tag = pcomm->part_tag();
46  Range tagged_sets;
47  CHKERR get_moab().get_entities_by_type_and_tag(0, MBENTITYSET, &part_tag,
48  tag_vals, 1, tagged_sets,
49  moab::Interface::UNION);
50  for (auto s : tagged_sets)
51  CHKERR get_moab().add_entities(s, &meshset, 1);
53  };
54  CHKERR add_meshset_to_partition(meshset);
55 
56  void const *tag_data[] = {name.c_str()};
57  int tag_sizes[1];
58  tag_sizes[0] = name.size();
59  CHKERR get_moab().tag_set_by_ptr(th_ProblemName, &meshset, 1, tag_data,
60  tag_sizes);
61  // create entry
62  auto p = pRoblems.insert(Problem(moab, meshset));
63  if (!p.second) {
66  MOFEM_LOG("SELF", Sev::error) << "Following problem can not be added:";
67  MOFEM_LOG("SELF", Sev::error)
68  << "Problem " << name << " id(" << id.to_ulong() << ") " << id
69  << " added meshset " << meshset;
70  MOFEM_LOG("SELF", Sev::error) << "List of problems already in databse:";
71  for (auto &p : pRoblems) {
72  MOFEM_LOG("SELF", Sev::error)
73  << p.getName() << " id(" << p.getId().to_ulong() << ") " << id
74  << " on meshset " << p.meshset;
75  }
76  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY, "Problem not added");
77  }
78 
79  MOFEM_LOG("WORLD", Sev::inform) << "Add problem " << name;
80 
82 }

◆ build_adjacencies() [1/3]

MoFEMErrorCode MoFEM::Core::build_adjacencies ( const BitRefLevel bit,
const BitRefLevel mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

build adjacencies

Parameters
bitadjacencies for refine level
maskmask for bit level

This function will get information of adjacent finite elements and fields of all entities. If this is not executed, partitioning the problem is not possible. Adjacency map is based on degrees of freedom adjacent to elements. This linked to geometric element connectivity.

If new degrees of freedom or new finite elements are added to the database, adjacency map has to be rebuild.

Implements MoFEM::CoreInterface.

Definition at line 814 of file FECore.cpp.

815  {
817  if (verb == -1)
818  verb = verbose;
819  Range ents;
820  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents);
821 
822  CHKERR build_adjacencies(ents, verb);
823 
825 }

◆ build_adjacencies() [2/3]

MoFEMErrorCode MoFEM::Core::build_adjacencies ( const BitRefLevel bit,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

build adjacencies

Parameters
bitadjacencies for refine level

This function will get information of adjacent finite elements and fields of all entities. If this is not executed, partitioning the problem is not possible. Adjacency map is based on degrees of freedom adjacent to elements. This linked to geometric element connectivity.

If new degrees of freedom or new finite elements are added to the database, adjacency map has to be rebuild.

Implements MoFEM::CoreInterface.

Definition at line 826 of file FECore.cpp.

826  {
828  if (verb == -1)
829  verb = verbose;
830  CHKERR build_adjacencies(bit, BitRefLevel().set(), verb);
831 
833 }

◆ build_adjacencies() [3/3]

MoFEMErrorCode MoFEM::Core::build_adjacencies ( const Range ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

build adjacencies

Parameters
listof entities

This function will get information of adjacent finite elements and fields of all entities. If this is not executed, partitioning the problem is not possible. Adjacency map is based on degrees of freedom adjacent to elements. This linked to geometric element connectivity.

If new degrees of freedom or new finite elements are added to the database, adjacency map has to be rebuild.

Implements MoFEM::CoreInterface.

Definition at line 742 of file FECore.cpp.

742  {
744  if (verb == DEFAULT_VERBOSITY)
745  verb = verbose;
746 
747  if (!((*buildMoFEM) & BUILD_FIELD))
748  SETERRQ(mofemComm, MOFEM_NOT_FOUND, "field not build");
749  if (!((*buildMoFEM) & BUILD_FE))
750  SETERRQ(mofemComm, MOFEM_NOT_FOUND, "fe not build");
751  for (auto peit = ents.pair_begin(); peit != ents.pair_end(); ++peit) {
752  auto fit = entsFiniteElements.get<Ent_mi_tag>().lower_bound(peit->first);
753  auto hi_fit =
754  entsFiniteElements.get<Ent_mi_tag>().upper_bound(peit->second);
755  for (; fit != hi_fit; ++fit) {
756  if ((*fit)->getBitFieldIdRow().none() &&
757  (*fit)->getBitFieldIdCol().none() &&
758  (*fit)->getBitFieldIdData().none())
759  continue;
760  int by = BYROW;
761  if ((*fit)->getBitFieldIdRow() != (*fit)->getBitFieldIdCol())
762  by |= BYCOL;
763  if ((*fit)->getBitFieldIdRow() != (*fit)->getBitFieldIdData())
764  by |= BYDATA;
765  FieldEntityEntFiniteElementAdjacencyMap_change_ByWhat modify_row(by);
766  auto hint = entFEAdjacencies.end();
767  for (auto e : *(*fit)->getRowFieldEntsPtr()) {
768  hint = entFEAdjacencies.emplace_hint(hint, e.lock(), *fit);
769  bool success = entFEAdjacencies.modify(hint, modify_row);
770  if (!success)
771  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
772  "modification unsuccessful");
773  }
774  if ((*fit)->getBitFieldIdRow() != (*fit)->getBitFieldIdCol()) {
775  int by = BYCOL;
776  if ((*fit)->getBitFieldIdCol() != (*fit)->getBitFieldIdData())
777  by |= BYDATA;
778  FieldEntityEntFiniteElementAdjacencyMap_change_ByWhat modify_col(by);
779  auto hint = entFEAdjacencies.end();
780  for (auto e : *(*fit)->getColFieldEntsPtr()) {
781  hint = entFEAdjacencies.emplace_hint(hint, e.lock(), *fit);
782  bool success = entFEAdjacencies.modify(hint, modify_col);
783  if (!success)
784  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
785  "modification unsuccessful");
786  }
787  }
788  if ((*fit)->getBitFieldIdRow() != (*fit)->getBitFieldIdData() ||
789  (*fit)->getBitFieldIdCol() != (*fit)->getBitFieldIdData()) {
790  FieldEntityEntFiniteElementAdjacencyMap_change_ByWhat modify_data(
791  BYDATA);
792  auto hint = entFEAdjacencies.end();
793  for (auto &e : (*fit)->getDataFieldEnts()) {
794  hint = entFEAdjacencies.emplace_hint(hint, e.lock(), *fit);
795  bool success = entFEAdjacencies.modify(hint, modify_data);
796  if (!success)
797  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
798  "modification unsuccessful");
799  }
800  }
801  }
802  }
803 
804  if (verb >= VERBOSE) {
805  MOFEM_LOG("WORLD", Sev::inform)
806  << "Number of adjacencies " << entFEAdjacencies.size();
808  }
809 
810  *buildMoFEM |= 1 << 2;
812 }

◆ build_field()

MoFEMErrorCode MoFEM::Core::build_field ( const std::string  field_name,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

build field by name

Parameters
field_name
verbm
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 1281 of file FieldCore.cpp.

1281  {
1283  auto field_it = fIelds.get<FieldName_mi_tag>().find(field_name);
1284  if (field_it == fIelds.get<FieldName_mi_tag>().end())
1285  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "Field < %s > not found",
1286  field_name.c_str());
1287 
1288  CHKERR this->buildField(*field_it, verb);
1289  if (verb > QUIET)
1292 }

◆ build_fields()

MoFEMErrorCode MoFEM::Core::build_fields ( int  verb = DEFAULT_VERBOSITY)
protectedvirtual

build fields

Implements MoFEM::CoreInterface.

Definition at line 1294 of file FieldCore.cpp.

1294  {
1296  if (verb == -1)
1297  verb = verbose;
1298 
1299  for (auto field : fIelds.get<BitFieldId_mi_tag>())
1300  CHKERR this->buildField(field, verb);
1301 
1302  *buildMoFEM = 1 << 0;
1303  if (verb > QUIET) {
1304  MOFEM_LOG("SYNC", Sev::verbose) << "Number of dofs " << dofsField.size();
1306  }
1307 
1309 }

◆ build_finite_elements() [1/3]

MoFEMErrorCode MoFEM::Core::build_finite_elements ( const BitRefLevel bit,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 705 of file FECore.cpp.

705  {
707  SETERRQ(mofemComm, MOFEM_NOT_IMPLEMENTED, "Not yet implemented");
709 }

◆ build_finite_elements() [2/3]

MoFEMErrorCode MoFEM::Core::build_finite_elements ( const string  fe_name,
const Range *const  ents_ptr = nullptr,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Build finite elements.

Build finite element data structures. Have to be run before problem and adjacencies are constructed.

Parameters
fe_nameName of finite element
ents_ptrPointer to range of finite elements
verbVerbosity level
Returns
Error code

Implements MoFEM::CoreInterface.

Definition at line 711 of file FECore.cpp.

713  {
715  if (verb == -1)
716  verb = verbose;
717 
718  auto fe_miit = finiteElements.get<FiniteElement_name_mi_tag>().find(fe_name);
719  if (fe_miit == finiteElements.get<FiniteElement_name_mi_tag>().end())
720  SETERRQ1(mofemComm, MOFEM_NOT_FOUND, "Finite element <%s> not found",
721  fe_name.c_str());
722 
723  CHKERR buildFiniteElements(*fe_miit, ents_ptr, verb);
724 
725  if (verb >= VERBOSE) {
726  auto &fe_ents = entsFiniteElements.get<Unique_mi_tag>();
727  auto miit = fe_ents.lower_bound(
728  EntFiniteElement::getLocalUniqueIdCalculate(0, (*fe_miit)->getFEUId()));
729  auto hi_miit =
731  get_id_for_max_type<MBENTITYSET>(), (*fe_miit)->getFEUId()));
732  const auto count = std::distance(miit, hi_miit);
733  MOFEM_LOG("SYNC", Sev::inform) << "Finite element " << fe_name
734  << " added. Nb. of elements added " << count;
736  }
737 
738  *buildMoFEM |= 1 << 1;
740 }

◆ build_finite_elements() [3/3]

MoFEMErrorCode MoFEM::Core::build_finite_elements ( int  verb = DEFAULT_VERBOSITY)
protectedvirtual

Build finite elements.

Build finite element data structures. Have to be run before problem and adjacencies are constructed.

Parameters
verbVerbosity level
Returns
Error code

Implements MoFEM::CoreInterface.

Definition at line 655 of file FECore.cpp.

655  {
657 
658  if (verb == DEFAULT_VERBOSITY)
659  verb = verbose;
660 
661  // loop Finite Elements
662  for (auto &fe : finiteElements)
663  CHKERR buildFiniteElements(fe, NULL, verb);
664 
665  if (verb > QUIET) {
666 
667  auto &fe_ents = entsFiniteElements.get<Unique_mi_tag>();
668  for (auto &fe : finiteElements) {
669  auto miit = fe_ents.lower_bound(
671  auto hi_miit =
673  get_id_for_max_type<MBENTITYSET>(), fe->getFEUId()));
674  const auto count = std::distance(miit, hi_miit);
675  MOFEM_LOG("SYNC", Sev::inform)
676  << "Finite element " << fe->getName()
677  << " added. Nb. of elements added " << count;
678  MOFEM_LOG("SYNC", Sev::noisy) << *fe;
679 
680  auto slg = MoFEM::LogManager::getLog("SYNC");
681  for (auto &field : fIelds) {
682  auto rec = slg.open_record(keywords::severity = Sev::verbose);
683  if (rec) {
684  logging::record_ostream strm(rec);
685  strm << "Field " << field->getName() << " on finite element: ";
686  if ((field->getId() & fe->getBitFieldIdRow()).any())
687  strm << "row ";
688  if ((field->getId() & fe->getBitFieldIdCol()).any())
689  strm << "columns ";
690  if ((field->getId() & fe->getBitFieldIdData()).any())
691  strm << "data";
692  strm.flush();
693  slg.push_record(boost::move(rec));
694  }
695  }
696  }
697 
699  }
700 
701  *buildMoFEM |= 1 << 1;
703 }

◆ build_problem_on_distributed_mesh()

MoFEMErrorCode MoFEM::Core::build_problem_on_distributed_mesh ( int  verb = DEFAULT_VERBOSITY)
protected

Definition at line 257 of file ProblemsCore.cpp.

257  {
259  if (verb == -1)
260  verb = verbose;
261  Problem_multiIndex::iterator p_miit = pRoblems.begin();
262  for (; p_miit != pRoblems.end(); p_miit++) {
263  CHKERR getInterface<ProblemsManager>()->buildProblemOnDistributedMesh(
264  const_cast<Problem *>(&*p_miit), verb);
265  }
267 }

◆ build_problems()

MoFEMErrorCode MoFEM::Core::build_problems ( int  verb = DEFAULT_VERBOSITY)
protected

Definition at line 317 of file ProblemsCore.cpp.

317  {
319  if (verb == -1)
320  verb = verbose;
321  if (!((*buildMoFEM) & BUILD_FIELD))
322  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY, "fields not build");
323  if (!((*buildMoFEM) & BUILD_FE))
324  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY, "FEs not build");
325  if (!((*buildMoFEM) & BUILD_ADJ))
326  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY, "adjacencies not build");
327  // iterate problems
328  Problem_multiIndex::iterator p_miit = pRoblems.begin();
329  for (; p_miit != pRoblems.end(); p_miit++) {
330  Problem *problem_ptr = const_cast<Problem *>(&*p_miit);
331  CHKERR getInterface<ProblemsManager>()->buildProblem(problem_ptr, false,
332  verb);
333  }
336 }

◆ buildField()

MoFEMErrorCode MoFEM::Core::buildField ( const boost::shared_ptr< Field > &  field,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 1232 of file FieldCore.cpp.

1233  {
1235  if (verb == -1)
1236  verb = verbose;
1237  if (verb > QUIET)
1238  MOFEM_LOG("SYNC", Sev::verbose) << "Build field " << field->getName();
1239 
1240  std::map<EntityType, int> dof_counter;
1241  std::map<EntityType, int> inactive_dof_counter;
1242 
1243  // Need to rebuild order table since number of dofs on each order when
1244  // field was created.
1245  if (field->getApproxBase() == USER_BASE)
1246  CHKERR field->rebuildDofsOrderMap();
1247 
1248  switch (field->getSpace()) {
1249  case NOFIELD:
1250  CHKERR this->buildFieldForNoField(field->getId(), dof_counter, verb);
1251  break;
1252  case L2:
1253  case H1:
1254  case HCURL:
1255  case HDIV:
1256  CHKERR this->buildFieldForL2H1HcurlHdiv(field->getId(), dof_counter,
1257  inactive_dof_counter, verb);
1258  break;
1259  default:
1260  SETERRQ(PETSC_COMM_SELF, MOFEM_NOT_IMPLEMENTED, "not implemented");
1261  }
1262 
1263  if (verb > QUIET) {
1264  int nb_added_dofs = 0;
1265  int nb_inactive_added_dofs = 0;
1266  for (auto const &it : dof_counter) {
1267  MOFEM_LOG("SYNC", Sev::verbose)
1268  << "Nb. of dofs (" << moab::CN::EntityTypeName(it.first) << ") "
1269  << it.second << " (inactive " << inactive_dof_counter[it.first]
1270  << ")";
1271  nb_added_dofs += it.second;
1272  nb_inactive_added_dofs += inactive_dof_counter[it.first];
1273  }
1274  MOFEM_LOG("SYNC", Sev::verbose)
1275  << "Nb. added dofs " << nb_added_dofs << " (number of inactive dofs "
1276  << nb_inactive_added_dofs << " )";
1277  }
1279 }

◆ buildFieldForL2H1HcurlHdiv()

MoFEMErrorCode MoFEM::Core::buildFieldForL2H1HcurlHdiv ( const BitFieldId  id,
std::map< EntityType, int > &  dof_counter,
std::map< EntityType, int > &  inactive_dof_counter,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 1120 of file FieldCore.cpp.

1122  {
1124  if (verb == -1)
1125  verb = verbose;
1126 
1127  // Find field
1128  auto &set_id = fIelds.get<BitFieldId_mi_tag>();
1129  auto field_it = set_id.find(id);
1130  if (field_it == set_id.end()) {
1131  SETERRQ(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "Field not found");
1132  }
1133  const int bit_number = field_it->get()->getBitNumber();
1134  const int rank = field_it->get()->getNbOfCoeffs();
1135 
1136  // Ents in the field meshset
1137  Range ents_of_id_meshset;
1138  CHKERR get_moab().get_entities_by_handle((*field_it)->meshSet,
1139  ents_of_id_meshset, false);
1140  if (verb > VERY_NOISY) {
1141  MOFEM_LOG_C("SYNC", Sev::noisy, "Ents in field %s meshset %d",
1142  (*field_it)->getName().c_str(), ents_of_id_meshset.size());
1143  }
1144 
1145  for (auto p_eit = ents_of_id_meshset.pair_begin();
1146  p_eit != ents_of_id_meshset.pair_end(); ++p_eit) {
1147 
1148  const EntityHandle first = p_eit->first;
1149  const EntityHandle second = p_eit->second;
1150  const auto lo_uid =
1151  FieldEntity::getLoLocalEntityBitNumber(bit_number, first);
1152  const auto hi_uid =
1153  FieldEntity::getHiLocalEntityBitNumber(bit_number, second);
1154 
1155  auto feit = entsFields.get<Unique_mi_tag>().lower_bound(lo_uid);
1156  if (feit == entsFields.get<Unique_mi_tag>().end())
1157  continue;
1158  auto hi_feit = entsFields.get<Unique_mi_tag>().upper_bound(hi_uid);
1159 
1160  // If there are DOFs in that range is more pragmatic to remove them
1161  // rather than to find sub-ranges or make them inactive
1162  auto dit = dofsField.get<Unique_mi_tag>().lower_bound(lo_uid);
1163  auto hi_dit = dofsField.get<Unique_mi_tag>().upper_bound(hi_uid);
1164  dofsField.get<Unique_mi_tag>().erase(dit, hi_dit);
1165 
1166  // Add vertices DOFs by bulk
1167  boost::shared_ptr<std::vector<DofEntity>> dofs_array =
1168  boost::make_shared<std::vector<DofEntity>>(std::vector<DofEntity>());
1169  // Add Sequence of DOFs to sequence container as weak_ptr
1170  int nb_dofs_on_ents = 0;
1171  for (auto tmp_feit = feit; tmp_feit != hi_feit; ++tmp_feit) {
1172  nb_dofs_on_ents += rank * tmp_feit->get()->getOrderNbDofs(
1173  tmp_feit->get()->getMaxOrder());
1174  }
1175 
1176  // Reserve memory
1177  dofs_array->reserve(nb_dofs_on_ents);
1178 
1179  // Create DOFs
1180  for (; feit != hi_feit; ++feit) {
1181  // Create dofs instances and shared pointers
1182  int DD = 0;
1183  // Loop orders (loop until max entity order is set)
1184  for (int oo = 0; oo <= feit->get()->getMaxOrder(); ++oo) {
1185  // Loop nb. dofs at order oo
1186  for (int dd = 0; dd < feit->get()->getOrderNbDofsDiff(oo); ++dd) {
1187  // Loop rank
1188  for (int rr = 0; rr < rank; ++rr, ++DD) {
1189  dofs_array->emplace_back(*feit, oo, rr, DD);
1190  ++dof_counter[feit->get()->getEntType()];
1191  }
1192  }
1193  }
1194  if (DD > feit->get()->getNbDofsOnEnt()) {
1195  std::ostringstream ss;
1196  ss << "rank " << rAnk << " ";
1197  ss << **feit << std::endl;
1198  SETERRQ3(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1199  "Expected number of DOFs on entity not equal to number added "
1200  "to database (DD = %d != %d = "
1201  "feit->get()->getNbDofsOnEnt())\n"
1202  "%s",
1203  DD, feit->get()->getNbDofsOnEnt(), ss.str().c_str());
1204  }
1205  }
1206 
1207  // Insert into Multi-Index container
1208  int dofs_field_size0 = dofsField.size();
1209  auto hint = dofsField.end();
1210  for (auto &v : *dofs_array)
1211  hint = dofsField.emplace_hint(hint, dofs_array, &v);
1212 
1213  // Add Sequence of DOFs to sequence container as weak_ptr
1214  field_it->get()->getDofSequenceContainer().push_back(dofs_array);
1215 
1216  // Check data consistency
1217  if (PetscUnlikely(static_cast<int>(dofs_array.use_count()) !=
1218  static_cast<int>(dofs_array->size() + 1))) {
1219  SETERRQ2(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1220  "Wrong use count %d != %d", dofs_array.use_count(),
1221  dofs_array->size() + 1);
1222  }
1223  if (dofs_field_size0 + dofs_array->size() != dofsField.size()) {
1224  SETERRQ2(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1225  "Wrong number of inserted DOFs %d != %d", dofs_array->size(),
1226  dofsField.size() - dofs_field_size0);
1227  }
1228  }
1230 }

◆ buildFieldForNoField()

MoFEMErrorCode MoFEM::Core::buildFieldForNoField ( const BitFieldId  id,
std::map< EntityType, int > &  dof_counter,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 1097 of file FieldCore.cpp.

1098  {
1100 
1101  if (verb == -1)
1102  verb = verbose;
1103 
1104  // find fields
1105  auto field_it = fIelds.get<BitFieldId_mi_tag>().find(id);
1106  if (field_it == fIelds.get<BitFieldId_mi_tag>().end())
1107  SETERRQ(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "Field not found");
1108 
1109  if (verb > QUIET)
1110  MOFEM_LOG("WORLD", Sev::noisy)
1111  << "Field " << (*field_it)->getName() << " core value < "
1112  << this->getValue() << " > field value () "
1113  << (*field_it)->getBitNumber() << " )";
1114 
1115  CHKERR this->buildFieldForNoFieldImpl(*field_it, dof_counter, verb);
1116 
1118 }

◆ buildFieldForNoFieldImpl()

MoFEMErrorCode MoFEM::Core::buildFieldForNoFieldImpl ( boost::shared_ptr< Field field_ptr,
std::map< EntityType, int > &  dof_counter,
int  verb 
)
protected

Definition at line 992 of file FieldCore.cpp.

994  {
996 
997  const auto bit_number = field_ptr->getBitNumber();
998 
999  // ents in the field meshset
1000  Range ents;
1001  CHKERR get_moab().get_entities_by_handle(field_ptr->getMeshset(), ents,
1002  false);
1003  if (verb > VERBOSE)
1004  MOFEM_LOG_C("SYNC", Sev::noisy, "Ents in field %s meshset %d\n",
1005  field_ptr->getName().c_str(), ents.size());
1006 
1007  // ent view by field id (in set all MoabEnts has the same FieldId)
1008  auto eiit = entsFields.get<Unique_mi_tag>().lower_bound(
1009  FieldEntity::getLoBitNumberUId(field_ptr->getBitNumber()));
1010  FieldEntity_multiIndex_ent_view ents_id_view;
1011  if (eiit != entsFields.get<Unique_mi_tag>().end()) {
1012  auto hi_eiit = entsFields.get<Unique_mi_tag>().upper_bound(
1013  FieldEntity::getHiBitNumberUId(field_ptr->getBitNumber()));
1014  std::copy(eiit, hi_eiit, std::back_inserter(ents_id_view));
1015  }
1016 
1017  boost::shared_ptr<const int> zero_order(new const int(0));
1018 
1019  for (auto ent : ents) {
1020  // search if field meshset is in database
1021  auto ref_ent_it = refinedEntities.get<Ent_mi_tag>().find(ent);
1022  if (ref_ent_it == refinedEntities.get<Ent_mi_tag>().end())
1023  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1024  "Entity is not in MoFEM database, entities in field meshset need "
1025  "to be seeded (i.e. bit ref level add to them)");
1026 
1027  auto add_dofs = [&](auto field_eit) {
1029  // create dofs on this entity (nb. of dofs is equal to rank)
1030  for (FieldCoefficientsNumber rank = 0; rank < field_ptr->getNbOfCoeffs();
1031  rank++) {
1032  // insert dof
1033  auto p = dofsField.insert(
1034  boost::make_shared<DofEntity>(field_eit, 0, rank, rank));
1035  if (p.second) {
1036  dof_counter[MBENTITYSET]++; // Count entities in the meshset
1037  } else
1038  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
1039  "Dof expected to be created");
1040  }
1042  };
1043 
1044  // create database entity
1045  auto field_ent_it = ents_id_view.get<1>().find(ent);
1046  if (field_ent_it == ents_id_view.get<1>().end()) {
1047 
1048  auto p = entsFields.insert(
1049 
1050  boost::make_shared<FieldEntity>(
1051  field_ptr, *ref_ent_it,
1053  *ref_ent_it),
1054  boost::shared_ptr<const int>(zero_order, zero_order.get()))
1055 
1056  );
1057 
1058  if ((*p.first)->getFieldRawPtr() != field_ptr.get())
1059  SETERRQ1(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1060  "Get field ent poiter and field pointer do not match for "
1061  "field %s",
1062  field_ptr->getName().c_str());
1063 
1064  if (!p.second)
1065  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1066  "Entity should be created");
1067 
1068  CHKERR add_dofs(*(p.first));
1069 
1070  } else {
1071 
1072  // If there are DOFs in that range is more pragmatic to remove them
1073  // rather than to find sub-ranges or make them inactive
1074  auto dit = dofsField.get<Unique_mi_tag>().lower_bound(
1075  FieldEntity::getLoLocalEntityBitNumber(bit_number, ent));
1076  auto hi_dit = dofsField.get<Unique_mi_tag>().upper_bound(
1077  FieldEntity::getHiLocalEntityBitNumber(bit_number, ent));
1078  dofsField.get<Unique_mi_tag>().erase(dit, hi_dit);
1079  CHKERR add_dofs(*field_ent_it);
1080  }
1081  }
1082 
1083  if (verb > VERBOSE) {
1084  auto lo_dof = dofsField.get<Unique_mi_tag>().lower_bound(
1085  FieldEntity::getLoBitNumberUId(field_ptr->getBitNumber()));
1086  auto hi_dof = dofsField.get<Unique_mi_tag>().upper_bound(
1087  FieldEntity::getHiBitNumberUId(field_ptr->getBitNumber()));
1088  for (; lo_dof != hi_dof; lo_dof++)
1089  MOFEM_LOG("SYNC", Sev::noisy) << **lo_dof;
1090  MOFEM_LOG_SEVERITY_SYNC(mofemComm, Sev::noisy);
1091  }
1092 
1094 }

◆ buildFiniteElements()

MoFEMErrorCode MoFEM::Core::buildFiniteElements ( const boost::shared_ptr< FiniteElement > &  fe,
const Range ents_ptr = NULL,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 459 of file FECore.cpp.

460  {
462  if (verb == DEFAULT_VERBOSITY)
463  verb = verbose;
464 
465  if (verb > QUIET)
466  MOFEM_LOG("SYNC", Sev::verbose)
467  << "Build Finite Elements " << fe->getName();
468 
469  auto &fields_by_id = fIelds.get<BitFieldId_mi_tag>();
470 
471  // Get id of mofem fields for row, col and data
472  enum IntLoop { ROW = 0, COL, DATA, LAST };
473  std::array<BitFieldId, LAST> fe_fields = {fe.get()->getBitFieldIdRow(),
474  fe.get()->getBitFieldIdCol(),
475  fe.get()->getBitFieldIdData()};
476 
477  // Get finite element meshset
478  EntityHandle meshset = get_finite_element_meshset(fe.get()->getId());
479 
480  // Get entities from finite element meshset // if meshset
481  Range fe_ents;
482  CHKERR get_moab().get_entities_by_handle(meshset, fe_ents, false);
483 
484  if (ents_ptr)
485  fe_ents = intersect(fe_ents, *ents_ptr);
486 
487  // Map entity uid to pointers
488  typedef std::vector<boost::weak_ptr<EntFiniteElement>> VecOfWeakFEPtrs;
489  VecOfWeakFEPtrs processed_fes;
490  processed_fes.reserve(fe_ents.size());
491 
492  int last_data_field_ents_view_size = 0;
493  int last_row_field_ents_view_size = 0;
494  int last_col_field_ents_view_size = 0;
495 
496  // Entities adjacent to entities
497  std::vector<EntityHandle> adj_ents;
498 
499  // Loop meshset finite element ents and add finite elements
500  for (Range::const_pair_iterator peit = fe_ents.const_pair_begin();
501  peit != fe_ents.const_pair_end(); peit++) {
502 
503  const auto first = peit->first;
504  const auto second = peit->second;
505 
506  // Find range of ref entities that is sequence
507  // note: iterator is a wrapper
508  // check if is in refinedFiniteElements database
509  auto ref_fe_miit =
510  refinedFiniteElements.get<Ent_mi_tag>().lower_bound(first);
511  if (ref_fe_miit == refinedFiniteElements.get<Ent_mi_tag>().end()) {
512  std::ostringstream ss;
513  ss << "refinedFiniteElements not in database ent = " << first << " type "
514  << type_from_handle(first) << " " << *fe;
515  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY, ss.str().c_str());
516  }
517  auto hi_ref_fe_miit =
518  refinedFiniteElements.get<Ent_mi_tag>().upper_bound(second);
519 
520  EntFiniteElement_multiIndex::iterator hint_p = entsFiniteElements.end();
521  for (; ref_fe_miit != hi_ref_fe_miit; ref_fe_miit++) {
522 
523  // Add finite element to database
524  hint_p = entsFiniteElements.emplace_hint(
525  hint_p, boost::make_shared<EntFiniteElement>(*ref_fe_miit, fe));
526  processed_fes.emplace_back(*hint_p);
527  auto fe_raw_ptr = hint_p->get();
528 
529  // Allocate space for entities view
530  bool row_as_data = false, col_as_row = false;
531  if (fe_fields[DATA] == fe_fields[ROW])
532  row_as_data = true;
533  if (fe_fields[ROW] == fe_fields[COL])
534  col_as_row = true;
535 
536  fe_raw_ptr->getDataFieldEntsPtr()->reserve(
537  last_data_field_ents_view_size);
538 
539  if (row_as_data) {
540  fe_raw_ptr->getRowFieldEntsPtr() = fe_raw_ptr->getDataFieldEntsPtr();
541  } else {
542  // row and col are different
543  if (fe_raw_ptr->getRowFieldEntsPtr() ==
544  fe_raw_ptr->getDataFieldEntsPtr())
545  fe_raw_ptr->getRowFieldEntsPtr() =
546  boost::make_shared<FieldEntity_vector_view>();
547  fe_raw_ptr->getRowFieldEntsPtr()->reserve(
548  last_row_field_ents_view_size);
549  }
550 
551  if (row_as_data && col_as_row) {
552  fe_raw_ptr->getColFieldEntsPtr() = fe_raw_ptr->getDataFieldEntsPtr();
553  } else if (col_as_row) {
554  fe_raw_ptr->getColFieldEntsPtr() = fe_raw_ptr->getRowFieldEntsPtr();
555  } else {
556  if (
557 
558  fe_raw_ptr->getColFieldEntsPtr() ==
559  fe_raw_ptr->getRowFieldEntsPtr() ||
560  fe_raw_ptr->getColFieldEntsPtr() ==
561  fe_raw_ptr->getDataFieldEntsPtr()
562 
563  )
564  fe_raw_ptr->getColFieldEntsPtr() =
565  boost::make_shared<FieldEntity_vector_view>();
566  fe_raw_ptr->getColFieldEntsPtr()->reserve(
567  last_col_field_ents_view_size);
568  }
569 
570  // Iterate over all field and check which one is on the element
571  for (unsigned int ii = 0; ii != BitFieldId().size(); ++ii) {
572 
573  // Common field id for ROW, COL and DATA
574  BitFieldId id_common = 0;
575  // Check if the field (ii) is added to finite element
576  for (int ss = 0; ss < LAST; ss++) {
577  id_common |= fe_fields[ss] & BitFieldId().set(ii);
578  }
579  if (id_common.none())
580  continue;
581 
582  // Find in database data associated with the field (ii)
583  const BitFieldId field_id = BitFieldId().set(ii);
584  auto miit = fields_by_id.find(field_id);
585  if (miit == fields_by_id.end())
586  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY, "Field not found");
587  auto field_bit_number = (*miit)->getBitNumber();
588 
589  // Loop over adjacencies of element and find field entities on those
590  // adjacencies, that create hash map map_uid_fe which is used later
591  const std::string field_name = miit->get()->getName();
592  const bool add_to_data = (field_id & fe_fields[DATA]).any();
593  const bool add_to_row = (field_id & fe_fields[ROW]).any();
594  const bool add_to_col = (field_id & fe_fields[COL]).any();
595 
596  // Resolve entities on element, those entities are used to build tag
597  // with dof uids on finite element tag
598  adj_ents.clear();
599  CHKERR fe_raw_ptr->getElementAdjacency(*miit, adj_ents);
600 
601  for (auto ent : adj_ents) {
602 
603  auto dof_it = entsFields.get<Unique_mi_tag>().find(
604  FieldEntity::getLocalUniqueIdCalculate(field_bit_number, ent));
605  if (dof_it != entsFields.get<Unique_mi_tag>().end()) {
606 
607  if (add_to_data) {
608  fe_raw_ptr->getDataFieldEntsPtr()->emplace_back(*dof_it);
609  }
610  if (add_to_row && !row_as_data) {
611  fe_raw_ptr->getRowFieldEntsPtr()->emplace_back(*dof_it);
612  }
613  if (add_to_col && !col_as_row) {
614  fe_raw_ptr->getColFieldEntsPtr()->emplace_back(*dof_it);
615  }
616 
617  }
618  }
619  }
620 
621  // Sort field ents by uid
622  auto uid_comp = [](const auto &a, const auto &b) {
623  return a.lock()->getLocalUniqueId() < b.lock()->getLocalUniqueId();
624  };
625 
626  // Sort all views
627 
628  // Data
629  sort(fe_raw_ptr->getDataFieldEntsPtr()->begin(),
630  fe_raw_ptr->getDataFieldEntsPtr()->end(), uid_comp);
631  last_data_field_ents_view_size =
632  fe_raw_ptr->getDataFieldEntsPtr()->size();
633 
634  // Row
635  if (!row_as_data) {
636  sort(fe_raw_ptr->getRowFieldEntsPtr()->begin(),
637  fe_raw_ptr->getRowFieldEntsPtr()->end(), uid_comp);
638  last_row_field_ents_view_size =
639  fe_raw_ptr->getRowFieldEntsPtr()->size();
640  }
641 
642  // Column
643  if (!col_as_row) {
644  sort(fe_raw_ptr->getColFieldEntsPtr()->begin(),
645  fe_raw_ptr->getColFieldEntsPtr()->end(), uid_comp);
646  last_col_field_ents_view_size =
647  fe_raw_ptr->getColFieldEntsPtr()->size();
648  }
649  }
650  }
651 
653 }

◆ cache_problem_entities()

MoFEMErrorCode MoFEM::Core::cache_problem_entities ( const std::string  prb_name,
CacheTupleWeakPtr  cache_ptr 
)
protectedvirtual

Cache variables.

Parameters
prb_name
cache_ptr
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 798 of file ProblemsCore.cpp.

799  {
801 
802  if (auto cache_ptr = cache_weak_ptr.lock()) {
803  auto p_miit = pRoblems.get<Problem_mi_tag>().find(prb_name);
804  if (p_miit == pRoblems.get<Problem_mi_tag>().end())
805  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "problem not in database %s",
806  prb_name.c_str());
807 
808  const BitRefLevel &prb_bit = p_miit->getBitRefLevel();
809  const BitRefLevel &prb_mask = p_miit->getBitRefLevelMask();
810  const BitFEId &prb_fe_id = p_miit->getBitFEId();
811 
812  auto &row_dofs = p_miit->numeredRowDofsPtr;
813  auto &col_dofs = p_miit->numeredColDofsPtr;
814 
815  auto &cache_data = std::get<0>(*cache_ptr);
816  auto &cache_row = std::get<1>(*cache_ptr);
817  auto &cache_col = std::get<2>(*cache_ptr);
818 
819  cache_row.resize(entsFields.size());
820  if (row_dofs != col_dofs)
821  cache_col.resize(entsFields.size());
822  cache_data.resize(entsFields.size());
823 
824  size_t idx = 0;
825  for (auto it = entsFields.begin(); it != entsFields.end(); ++it, ++idx) {
826 
827  const auto uid = (*it)->getLocalUniqueId();
828  auto r = entFEAdjacencies.get<Unique_mi_tag>().equal_range(uid);
829  for (auto lo = r.first; lo != r.second; ++lo) {
830 
831  if ((lo->getBitFEId() & prb_fe_id).any()) {
832 
833  const BitRefLevel &fe_bit = lo->entFePtr->getBitRefLevel();
834 
835  // if entity is not problem refinement level
836  if (((fe_bit & prb_mask) != fe_bit) || ((fe_bit & prb_bit).none()))
837  continue;
838 
839  auto cache_numered_dofs = [&](auto &numered_dofs, auto &cache_vec,
840  auto &ent_cache) {
841  auto dit = numered_dofs->lower_bound(uid);
842  decltype(dit) hi_dit;
843  if (dit != numered_dofs->end())
844  hi_dit = numered_dofs->upper_bound(
845  uid | static_cast<UId>(MAX_DOFS_ON_ENTITY - 1));
846  else
847  hi_dit = dit;
848 
849  ent_cache = boost::shared_ptr<EntityCacheNumeredDofs>(
850  cache_ptr, &(cache_vec[idx]));
851  cache_vec[idx].loHi = {dit, hi_dit};
852  };
853 
854  auto cache_dofs = [&](auto &dofs, auto &cache_vec, auto &ent_cache) {
855  auto dit = dofs.lower_bound(uid);
856  decltype(dit) hi_dit;
857  if (dit != dofs.end())
858  hi_dit = dofs.upper_bound(
859  uid | static_cast<UId>(MAX_DOFS_ON_ENTITY - 1));
860  else
861  hi_dit = dit;
862 
863  ent_cache = boost::shared_ptr<EntityCacheDofs>(cache_ptr,
864  &(cache_vec[idx]));
865  cache_vec[idx].loHi = {dit, hi_dit};
866  };
867 
868  cache_numered_dofs(row_dofs, cache_row, (*it)->entityCacheRowDofs);
869  if (row_dofs != col_dofs) {
870  if (cache_col.size() != entsFields.size())
871  cache_col.resize(entsFields.size());
872  cache_numered_dofs(col_dofs, cache_col, (*it)->entityCacheColDofs);
873  } else {
874  (*it)->entityCacheColDofs = (*it)->entityCacheRowDofs;
875  }
876 
877  cache_dofs(dofsField, cache_data, (*it)->entityCacheDataDofs);
878 
879  break;
880  }
881  }
882  }
883  } else {
884  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY, "Cache not allocated");
885  }
886 
888 }

◆ check_field()

bool MoFEM::Core::check_field ( const std::string &  name) const
protectedvirtual

check if field is in database

Parameters
namefield name
Returns
true if field exist

Implements MoFEM::CoreInterface.

Definition at line 57 of file FieldCore.cpp.

57  {
58  auto miit = fIelds.get<FieldName_mi_tag>().find(name);
59  if (miit == fIelds.get<FieldName_mi_tag>().end())
60  return false;
61  else
62  return true;
63 }

◆ check_finite_element()

bool MoFEM::Core::check_finite_element ( const std::string &  name) const
protectedvirtual

Check if finite element is in database.

Parameters
nameName of finite element
Returns
true if element is declared

Implements MoFEM::CoreInterface.

Definition at line 35 of file FECore.cpp.

35  {
36  auto miit = finiteElements.get<FiniteElement_name_mi_tag>().find(name);
37  if (miit == finiteElements.get<FiniteElement_name_mi_tag>().end())
38  return false;
39  else
40  return true;
41 }

◆ check_number_of_ents_in_ents_field() [1/2]

MoFEMErrorCode MoFEM::Core::check_number_of_ents_in_ents_field ( ) const
protectedvirtual

check data consistency in entitiesPtr

Implements MoFEM::CoreInterface.

Definition at line 1413 of file FieldCore.cpp.

1413  {
1415  for (auto &it : fIelds.get<FieldName_mi_tag>()) {
1416  if (it->getSpace() == NOFIELD)
1417  continue; // FIXME: should be treated properly, not test is just
1418  // skipped for this NOFIELD space
1419  EntityHandle meshset = it->getMeshset();
1420  int num_entities;
1421  CHKERR get_moab().get_number_entities_by_handle(meshset, num_entities);
1422 
1423  auto count_field_ents = [&]() {
1424  auto bit_number = it->getBitNumber();
1425  auto low_eit = entsFields.get<Unique_mi_tag>().lower_bound(
1426  FieldEntity::getLoBitNumberUId(bit_number));
1427  auto hi_eit = entsFields.get<Unique_mi_tag>().upper_bound(
1428  FieldEntity::getHiBitNumberUId(bit_number));
1429  return std::distance(low_eit, hi_eit);
1430  };
1431 
1432  if (count_field_ents() > (unsigned int)num_entities) {
1433  SETERRQ1(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1434  "not equal number of entities in meshset and field "
1435  "multiindex < %s >",
1436  it->getName().c_str());
1437  }
1438  }
1440 }

◆ check_number_of_ents_in_ents_field() [2/2]

MoFEMErrorCode MoFEM::Core::check_number_of_ents_in_ents_field ( const std::string &  name) const
protectedvirtual

check data consistency in entitiesPtr

Implements MoFEM::CoreInterface.

Definition at line 1385 of file FieldCore.cpp.

1385  {
1387  auto it = fIelds.get<FieldName_mi_tag>().find(name);
1388  if (it == fIelds.get<FieldName_mi_tag>().end()) {
1389  SETERRQ1(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1390  "field not found < %s >", name.c_str());
1391  }
1392  EntityHandle meshset = (*it)->getMeshset();
1393  int num_entities;
1394  CHKERR get_moab().get_number_entities_by_handle(meshset, num_entities);
1395 
1396  auto count_field_ents = [&]() {
1397  auto bit_number = (*it)->getBitNumber();
1398  auto low_eit = entsFields.get<Unique_mi_tag>().lower_bound(
1399  FieldEntity::getLoBitNumberUId(bit_number));
1400  auto hi_eit = entsFields.get<Unique_mi_tag>().upper_bound(
1401  FieldEntity::getHiBitNumberUId(bit_number));
1402  return std::distance(low_eit, hi_eit);
1403  };
1404 
1405  if (count_field_ents() > (unsigned int)num_entities) {
1406  SETERRQ1(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
1407  "not equal number of entities in meshset and field multiindex "
1408  "< %s >",
1409  name.c_str());
1410  }
1412 }

◆ check_number_of_ents_in_ents_finite_element() [1/2]

MoFEMErrorCode MoFEM::Core::check_number_of_ents_in_ents_finite_element ( ) const
protectedvirtual

check data consistency in entsFiniteElements

Implements MoFEM::CoreInterface.

Definition at line 885 of file FECore.cpp.

885  {
887  FiniteElement_multiIndex::index<FiniteElement_name_mi_tag>::type::iterator it;
888  it = finiteElements.get<FiniteElement_name_mi_tag>().begin();
889  for (; it != finiteElements.get<FiniteElement_name_mi_tag>().end(); it++) {
890  EntityHandle meshset = (*it)->getMeshset();
891 
892  int num_entities;
893  CHKERR get_moab().get_number_entities_by_handle(meshset, num_entities);
894 
895  auto counts_fes = [&]() {
896  return std::distance(get_fe_by_name_begin((*it)->getName()),
897  get_fe_by_name_end((*it)->getName()));
898  };
899 
900  if (counts_fes() != static_cast<size_t>(num_entities)) {
902  "not equal number of entities in meshset and finite elements "
903  "multiindex < %s >",
904  (*it)->getName().c_str());
905  }
906  }
908 }

◆ check_number_of_ents_in_ents_finite_element() [2/2]

MoFEMErrorCode MoFEM::Core::check_number_of_ents_in_ents_finite_element ( const std::string &  name) const
protectedvirtual

check data consistency in entsFiniteElements

Implements MoFEM::CoreInterface.

Definition at line 858 of file FECore.cpp.

859  {
861  FiniteElement_multiIndex::index<FiniteElement_name_mi_tag>::type::iterator it;
862  it = finiteElements.get<FiniteElement_name_mi_tag>().find(name);
863  if (it == finiteElements.get<FiniteElement_name_mi_tag>().end()) {
864  SETERRQ1(mofemComm, 1, "finite element not found < %s >", name.c_str());
865  }
866  EntityHandle meshset = (*it)->getMeshset();
867 
868  int num_entities;
869  CHKERR get_moab().get_number_entities_by_handle(meshset, num_entities);
870 
871  auto counts_fes = [&]() {
872  return std::distance(get_fe_by_name_begin((*it)->getName()),
873  get_fe_by_name_end((*it)->getName()));
874  };
875 
876  if (counts_fes() != static_cast<size_t>(num_entities)) {
878  "not equal number of entities in meshset and finite elements "
879  "multiindex < %s >",
880  (*it)->getName().c_str());
881  }
883 }

◆ check_problem()

bool MoFEM::CoreTmp< 0 >::check_problem ( const std::string  name)
protectedvirtual

check if problem exist

Parameters
nameproblem name
Returns
true if problem is in database

Implements MoFEM::CoreInterface.

◆ clear_adjacencies_entities() [1/3]

MoFEMErrorCode MoFEM::Core::clear_adjacencies_entities ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

clear adjacency map for entities on given bit level

Parameters
bit
mask

Implements MoFEM::CoreInterface.

Definition at line 201 of file DeleteCore.cpp.

203  {
205  if (verb == -1)
206  verb = verbose;
207  Range ents;
208  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
211 }

◆ clear_adjacencies_entities() [2/3]

MoFEMErrorCode MoFEM::Core::clear_adjacencies_entities ( const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

clear adjacencies for field entities by entities

Implements MoFEM::CoreInterface.

Definition at line 213 of file DeleteCore.cpp.

213  {
215  if (verb == -1)
216  verb = verbose;
217  for (Range::const_pair_iterator p_eit = ents.pair_begin();
218  p_eit != ents.pair_end(); ++p_eit) {
219  const EntityHandle first = p_eit->first;
220  const EntityHandle second = p_eit->second;
221  FieldEntityEntFiniteElementAdjacencyMap_multiIndex::index<
222  Ent_mi_tag>::type::iterator ait,
223  hi_ait;
224  ait = entFEAdjacencies.get<Ent_mi_tag>().lower_bound(first);
225  hi_ait = entFEAdjacencies.get<Ent_mi_tag>().upper_bound(second);
226  entFEAdjacencies.get<Ent_mi_tag>().erase(ait, hi_ait);
227  }
229 }

◆ clear_adjacencies_entities() [3/3]

MoFEMErrorCode MoFEM::Core::clear_adjacencies_entities ( const std::string  name,
const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

clear adjacencies for field entities by entities and field namd

Implements MoFEM::CoreInterface.

Definition at line 231 of file DeleteCore.cpp.

232  {
234  if (verb == -1)
235  verb = verbose;
236 
237  const Field *field_ptr = get_field_structure(name);
238  int field_bit_number = field_ptr->getBitNumber();
239 
240  for (Range::const_pair_iterator p_eit = ents.pair_begin();
241  p_eit != ents.pair_end(); p_eit++) {
242 
243  // First and last handle
244  const EntityHandle first = p_eit->first;
245  const EntityHandle second = p_eit->second;
246 
247  // Get UId
248  UId first_uid =
249  FieldEntity::getLocalUniqueIdCalculate(field_bit_number, first);
250  UId second_uid =
251  FieldEntity::getLocalUniqueIdCalculate(field_bit_number, second);
252 
253  // Find adjacencies
254  auto ait = entFEAdjacencies.get<Unique_mi_tag>().lower_bound(first_uid);
255  auto hi_ait = entFEAdjacencies.get<Unique_mi_tag>().upper_bound(second_uid);
256  entFEAdjacencies.get<Unique_mi_tag>().erase(ait, hi_ait);
257  }
259 }

◆ clear_adjacencies_finite_elements() [1/3]

MoFEMErrorCode MoFEM::Core::clear_adjacencies_finite_elements ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

clear adjacency map for finite elements on given bit level

Parameters
bit
mask

Implements MoFEM::CoreInterface.

Definition at line 312 of file DeleteCore.cpp.

314  {
316  Range ents;
317  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
320 }

◆ clear_adjacencies_finite_elements() [2/3]

MoFEMErrorCode MoFEM::Core::clear_adjacencies_finite_elements ( const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 322 of file DeleteCore.cpp.

323  {
325  if (verb == -1)
326  verb = verbose;
327  for (Range::const_pair_iterator p_eit = ents.pair_begin();
328  p_eit != ents.pair_end(); p_eit++) {
329  EntityHandle first = p_eit->first;
330  EntityHandle second = p_eit->second;
331  FieldEntityEntFiniteElementAdjacencyMap_multiIndex::index<
332  FEEnt_mi_tag>::type::iterator ait,
333  hi_ait;
334  ait = entFEAdjacencies.get<FEEnt_mi_tag>().lower_bound(first);
335  hi_ait = entFEAdjacencies.get<FEEnt_mi_tag>().upper_bound(second);
336  entFEAdjacencies.get<FEEnt_mi_tag>().erase(ait, hi_ait);
337  }
339 }

◆ clear_adjacencies_finite_elements() [3/3]

MoFEMErrorCode MoFEM::Core::clear_adjacencies_finite_elements ( const std::string  name,
const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 341 of file DeleteCore.cpp.

343  {
345  if (verb == -1)
346  verb = verbose;
347 
348  FiniteElement_multiIndex::index<FiniteElement_name_mi_tag>::type::iterator
349  it_fe = finiteElements.get<FiniteElement_name_mi_tag>().find(name);
350  if (it_fe != finiteElements.get<FiniteElement_name_mi_tag>().end()) {
351 
352  const auto fe_uid = (*it_fe)->getFEUId();
353 
354  for (Range::const_pair_iterator p_eit = ents.pair_begin();
355  p_eit != ents.pair_end(); p_eit++) {
356 
357  // First and last handle
358  const EntityHandle first = p_eit->first;
359  const EntityHandle second = p_eit->second;
360 
361  // Get UId
362  UId first_uid =
364  UId second_uid =
366 
367  // Find and remove adjacencies
368  FieldEntityEntFiniteElementAdjacencyMap_multiIndex::index<
369  FE_Unique_mi_tag>::type::iterator ait,
370  hi_ait;
371  ait = entFEAdjacencies.get<FE_Unique_mi_tag>().lower_bound(first_uid);
372  hi_ait = entFEAdjacencies.get<FE_Unique_mi_tag>().upper_bound(second_uid);
373  entFEAdjacencies.get<FE_Unique_mi_tag>().erase(ait, hi_ait);
374  }
375  }
377 }

◆ clear_database()

MoFEMErrorCode MoFEM::Core::clear_database ( int  verb = DEFAULT_VERBOSITY)
protectedvirtual

Clear database.

Parameters
verbVerbosity level
Returns
Error code

Implements MoFEM::CoreInterface.

Definition at line 728 of file Core.cpp.

728  {
730  if (verb == -1)
731  verb = verbose;
732  CHKERR clearMap();
734 }

◆ clear_dofs_fields() [1/2]

MoFEMErrorCode MoFEM::Core::clear_dofs_fields ( const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Clear dofs by ents

Implements MoFEM::CoreInterface.

Definition at line 57 of file DeleteCore.cpp.

57  {
59  if (verb == -1)
60  verb = verbose;
61 
62  for (Range::const_pair_iterator p_eit = ents.pair_begin();
63  p_eit != ents.pair_end(); p_eit++) {
64  EntityHandle first = p_eit->first;
65  EntityHandle second = p_eit->second;
66  // get dofs range
67  DofEntityByEnt::iterator dit, hi_dit;
68  dit = dofsField.get<Ent_mi_tag>().lower_bound(first);
69  if (dit == dofsField.get<Ent_mi_tag>().end())
70  continue;
71  hi_dit = dofsField.get<Ent_mi_tag>().upper_bound(second);
72  // finally clear dofs
73  dofsField.get<Ent_mi_tag>().erase(dit, hi_dit);
74  }
76 }

◆ clear_dofs_fields() [2/2]

MoFEMErrorCode MoFEM::Core::clear_dofs_fields ( const std::string  name,
const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Clear dofs by field name and ents

Implements MoFEM::CoreInterface.

Definition at line 78 of file DeleteCore.cpp.

79  {
81  if (verb == -1)
82  verb = verbose;
83 
84  const auto bit_number = get_field_bit_number(name);
85 
86  for (Range::const_pair_iterator p_eit = ents.pair_begin();
87  p_eit != ents.pair_end(); p_eit++) {
88  const auto first = p_eit->first;
89  const auto second = p_eit->second;
90  const auto lo_uid = DofEntity::getLoFieldEntityUId(bit_number, first);
91  const auto hi_uid = DofEntity::getHiFieldEntityUId(bit_number, second);
92  auto dit = dofsField.get<Unique_mi_tag>().lower_bound(lo_uid);
93  auto hi_dit = dofsField.get<Unique_mi_tag>().upper_bound(hi_uid);
94  dofsField.get<Unique_mi_tag>().erase(dit, hi_dit);
95  }
97 }

◆ clear_dofs_fields_by_bit_ref()

MoFEMErrorCode MoFEM::Core::clear_dofs_fields_by_bit_ref ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Clear dofs by bit level

Implements MoFEM::CoreInterface.

Definition at line 45 of file DeleteCore.cpp.

47  {
49  if (verb == -1)
50  verb = verbose;
51  Range ents;
52  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
53  CHKERR clear_dofs_fields(ents, verb);
55 }

◆ clear_ents_fields() [1/2]

MoFEMErrorCode MoFEM::Core::clear_ents_fields ( const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Clear entities by field name

Implements MoFEM::CoreInterface.

Definition at line 113 of file DeleteCore.cpp.

113  {
115  if (verb == -1)
116  verb = verbose;
117  CHKERR clear_dofs_fields(ents, verb);
119  for (Range::const_pair_iterator p_eit = ents.pair_begin();
120  p_eit != ents.pair_end(); p_eit++) {
121  EntityHandle first = p_eit->first;
122  EntityHandle second = p_eit->second;
123  FieldEntity_multiIndex::index<Ent_mi_tag>::type::iterator dit, hi_dit;
124  dit = entsFields.get<Ent_mi_tag>().lower_bound(first);
125  hi_dit = entsFields.get<Ent_mi_tag>().upper_bound(second);
126  entsFields.get<Ent_mi_tag>().erase(dit, hi_dit);
127  }
129 }

◆ clear_ents_fields() [2/2]

MoFEMErrorCode MoFEM::Core::clear_ents_fields ( const std::string  name,
const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Clear entities by field name

Implements MoFEM::CoreInterface.

Definition at line 131 of file DeleteCore.cpp.

132  {
134  if (verb == -1)
135  verb = verbose;
136  const auto bit_number = get_field_bit_number(name);
137  CHKERR clear_dofs_fields(name, ents, verb);
138  CHKERR clear_adjacencies_entities(name, ents, verb);
139  for (Range::const_pair_iterator p_eit = ents.pair_begin();
140  p_eit != ents.pair_end(); p_eit++) {
141  const auto first = p_eit->first;
142  const auto second = p_eit->second;
143  auto dit = entsFields.get<Unique_mi_tag>().lower_bound(
144  FieldEntity::getLocalUniqueIdCalculate(bit_number, first));
145  auto hi_dit = entsFields.get<Unique_mi_tag>().upper_bound(
146  FieldEntity::getLocalUniqueIdCalculate(bit_number, second));
147  entsFields.get<Unique_mi_tag>().erase(dit, hi_dit);
148  }
150 }

◆ clear_ents_fields_by_bit_ref()

MoFEMErrorCode MoFEM::Core::clear_ents_fields_by_bit_ref ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Clear ents by bit level

Implements MoFEM::CoreInterface.

Definition at line 99 of file DeleteCore.cpp.

101  {
103  if (verb == -1)
104  verb = verbose;
105  Range ents;
106  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
107  CHKERR clear_dofs_fields(ents, verb);
109  CHKERR clear_ents_fields(ents, verb);
111 }

◆ clear_finite_elements() [1/2]

MoFEMErrorCode MoFEM::Core::clear_finite_elements ( const Range ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

clear finite elements

Implements MoFEM::CoreInterface.

Definition at line 273 of file DeleteCore.cpp.

273  {
275  if (verb == -1)
276  verb = verbose;
278  for (Range::const_pair_iterator p_eit = ents.pair_begin();
279  p_eit != ents.pair_end(); p_eit++) {
280  EntityHandle first = p_eit->first;
281  EntityHandle second = p_eit->second;
282  EntFiniteElement_multiIndex::index<Ent_mi_tag>::type::iterator fit, hi_fit;
283  fit = entsFiniteElements.get<Ent_mi_tag>().lower_bound(first);
284  hi_fit = entsFiniteElements.get<Ent_mi_tag>().upper_bound(second);
285  entsFiniteElements.get<Ent_mi_tag>().erase(fit, hi_fit);
286  }
288 }

◆ clear_finite_elements() [2/2]

MoFEMErrorCode MoFEM::Core::clear_finite_elements ( const std::string &  fe_name,
const Range ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

clear finite elements

Implements MoFEM::CoreInterface.

Definition at line 290 of file DeleteCore.cpp.

291  {
293  if (verb == -1)
294  verb = verbose;
295  CHKERR clear_adjacencies_finite_elements(fe_name, ents, verb);
296  auto fe_miit = finiteElements.get<FiniteElement_name_mi_tag>().find(fe_name);
297  if (fe_miit == finiteElements.get<FiniteElement_name_mi_tag>().end()) {
298  for (Range::const_pair_iterator p_eit = ents.pair_begin();
299  p_eit != ents.pair_end(); p_eit++) {
300  auto fit = entsFiniteElements.get<Unique_mi_tag>().lower_bound(
302  (*fe_miit)->getFEUId()));
303  auto hi_fit = entsFiniteElements.get<Unique_mi_tag>().upper_bound(
305  (*fe_miit)->getFEUId()));
306  fit = entsFiniteElements.get<Unique_mi_tag>().erase(fit, hi_fit);
307  }
308  }
310 }

◆ clear_finite_elements_by_bit_ref()

MoFEMErrorCode MoFEM::Core::clear_finite_elements_by_bit_ref ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

clear finite elements

Implements MoFEM::CoreInterface.

Definition at line 261 of file DeleteCore.cpp.

263  {
265  if (verb == -1)
266  verb = verbose;
267  Range ents;
268  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
269  CHKERR clear_finite_elements(ents, verb);
271 }

◆ clear_inactive_dofs()

MoFEMErrorCode MoFEM::Core::clear_inactive_dofs ( int  verb = DEFAULT_VERBOSITY)
protectedvirtual

Clear inactive dofs

Implements MoFEM::CoreInterface.

Definition at line 29 of file DeleteCore.cpp.

29  {
31  if (verb == -1)
32  verb = verbose;
33  Range ents;
34  for (DofEntity_multiIndex::iterator dit = dofsField.begin();
35  dit != dofsField.end();) {
36  if (!dit->get()->getActive()) {
37  dit = dofsField.erase(dit);
38  } else {
39  ++dit;
40  }
41  }
43 }

◆ clear_problem()

MoFEMErrorCode MoFEM::Core::clear_problem ( const std::string  name,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

clear problem

Implements MoFEM::CoreInterface.

Definition at line 269 of file ProblemsCore.cpp.

269  {
271  if (verb == -1)
272  verb = verbose;
274  ProblemsByName &prob_by_name = pRoblems.get<Problem_mi_tag>();
275  ProblemsByName::iterator p_miit = prob_by_name.find(problem_name);
276  if (p_miit == prob_by_name.end()) {
277  SETERRQ1(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
278  "problem < %s > not found, (top tip: check spelling)",
279  problem_name.c_str());
280  }
281  // zero rows
282  bool success = prob_by_name.modify(p_miit, ProblemZeroNbRowsChange());
283  if (!success)
284  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
285  "modification unsuccessful");
286  // zero cols
287  success = prob_by_name.modify(p_miit, ProblemZeroNbColsChange());
288  if (!success)
289  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
290  "modification unsuccessful");
291  // clear finite elements
292  success =
293  prob_by_name.modify(p_miit, ProblemClearNumeredFiniteElementsChange());
294  if (!success)
295  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
296  "modification unsuccessful");
297  // clear data structures
298  success = prob_by_name.modify(p_miit, ProblemClearSubProblemData());
299  if (!success)
300  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
301  "modification unsuccessful");
302  success = prob_by_name.modify(p_miit, ProblemClearComposedProblemData());
303  if (!success)
304  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
305  "modification unsuccessful");
306  if (p_miit->getRowDofsSequence())
307  p_miit->getRowDofsSequence()->clear();
308  if (p_miit->getColDofsSequence())
309  p_miit->getColDofsSequence()->clear();
310  if (p_miit->getSubData())
311  p_miit->getSubData().reset();
312  if (p_miit->getComposedProblemsData())
313  p_miit->getComposedProblemsData().reset();
315 }

◆ clear_problems()

MoFEMErrorCode MoFEM::Core::clear_problems ( int  verb = DEFAULT_VERBOSITY)
protectedvirtual

clear problems

Implements MoFEM::CoreInterface.

Definition at line 338 of file ProblemsCore.cpp.

338  {
340  if (verb == -1)
341  verb = verbose;
342  // iterate problems
343  for (auto p_miit = pRoblems.begin(); p_miit != pRoblems.end(); p_miit++)
344  CHKERR clear_problem(p_miit->getName(), verb);
346 }

◆ clearMap()

MoFEMErrorCode MoFEM::Core::clearMap ( )
protected

Cleaning database.

Definition at line 503 of file Core.cpp.

503  {
505  // Cleaning databases in interfaces
506  CHKERR getInterface<SeriesRecorder>()->clearMap();
507  CHKERR getInterface<MeshsetsManager>()->clearMap();
508  CHKERR getInterface<CutMeshInterface>()->clearMap();
509  // Cleaning databases
510  refinedEntities.clear();
511  refinedFiniteElements.clear();
512  fIelds.clear();
513  entsFields.clear();
514  dofsField.clear();
515  finiteElements.clear();
516  entsFiniteElements.clear();
517  entFEAdjacencies.clear();
518  pRoblems.clear();
520 }

◆ coreGenericConstructor()

MoFEMErrorCode MoFEM::Core::coreGenericConstructor ( moab::Interface &  moab,
MPI_Comm  comm,
const int  verbose 
)
protected

Definition at line 197 of file Core.cpp.

198  {
200 
201  // This is deprecated ONE should use MoFEM::Core::Initialize
203  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
204  "MoFEM globally is not initialised, call MoFEM::Core::Initialize");
205 
206  // Create duplicate communicator
207  wrapMPIMOABComm = boost::make_shared<WrapMPIComm>(comm, false);
208 
209  MPI_Comm_size(mofemComm, &sIze);
210  MPI_Comm_rank(mofemComm, &rAnk);
211 
212  // CHeck if moab has set communicator if not set communicator interbally
213  ParallelComm *pComm = ParallelComm::get_pcomm(&moab, MYPCOMM_INDEX);
214  if (pComm == NULL)
215  pComm = new ParallelComm(&moab, wrapMPIMOABComm->get_comm());
216 
217  // Register interfaces for this implementation
218  CHKERR registerInterface<UnknownInterface>();
219  CHKERR registerInterface<CoreInterface>();
220  CHKERR registerInterface<DeprecatedCoreInterface>();
221 
222  // Register MOFEM events in PETSc
223  PetscLogEventRegister("FE_preProcess", 0, &MOFEM_EVENT_preProcess);
224  PetscLogEventRegister("FE_operator", 0, &MOFEM_EVENT_operator);
225  PetscLogEventRegister("FE_postProcess", 0, &MOFEM_EVENT_postProcess);
226  PetscLogEventRegister("MoFEMCreateMat", 0, &MOFEM_EVENT_createMat);
227 
228  MOFEM_LOG_CHANNEL("WORLD");
229  MOFEM_LOG_CHANNEL("SELF");
230  MOFEM_LOG_CHANNEL("SYNC");
231 
233 }

◆ create_vertices_and_add_to_field()

MoFEMErrorCode MoFEM::Core::create_vertices_and_add_to_field ( const std::string  name,
const double  coords[],
int  size,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Create a vertices and add to field object.

Create vertices and add them to field. Those vertices would be carring DOFs of the filed.

Note
This function is typically used when NOFIELD is created, for example load factor in arc-length control.
Parameters
namename of the field
bitbit ref level of the created vertices
coordsof the vertices
sizenumber of vertices
verbverbosity level
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 443 of file FieldCore.cpp.

445  {
447 
448  if (verb == DEFAULT_VERBOSITY)
449  verb = verbose;
450 
451  Range verts;
452 
453  auto create_vertices = [&]() {
455 
456  vector<double *> arrays_coord;
457  EntityHandle startv = 0;
458  ReadUtilIface *iface;
459  CHKERR get_moab().query_interface(iface);
460  CHKERR iface->get_node_coords(3, size, 0, startv, arrays_coord);
461  verts.insert(startv, startv + size - 1);
462  for (int n = 0; n != size; ++n)
463  for (auto d : {0, 1, 2})
464  arrays_coord[d][n] = coords[3 * n + d];
465 
467  };
468 
469  auto add_verts_to_field = [&]() {
471  EntityHandle field_meshset = get_field_meshset(name);
472  CHKERR get_moab().add_entities(field_meshset, verts);
474  };
475 
476  CHKERR create_vertices();
477  CHKERR add_verts_to_field();
478 
480 }

◆ delete_ents_by_bit_ref()

MoFEMErrorCode MoFEM::Core::delete_ents_by_bit_ref ( const BitRefLevel  bit,
const BitRefLevel  mask,
const bool  remove_parent = false,
int  verb = DEFAULT_VERBOSITY,
MoFEMTypes  mf = MF_ZERO 
)
protectedvirtual

delete entities form mofem and moab database

Implements MoFEM::CoreInterface.

Definition at line 535 of file DeleteCore.cpp.

538  {
540  if (verb == -1)
541  verb = verbose;
542 
543  Range ents;
544  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
545  Range ents_meshsets = ents.subset_by_type(MBENTITYSET);
546  ents = subtract(ents, ents_meshsets);
547  if(ents.empty()) {
548  if (verb >= VERBOSE)
549  MOFEM_LOG("WORLD", Sev::verbose) << "Nb. of deleted entities 0";
551  }
552 
553  if (verb >= VERBOSE)
554  MOFEM_LOG("WORLD", Sev::noisy) << "Deleted ents:\n" << ents;
555 
556  CHKERR remove_ents(ents, verb);
557 
558  // remove parent
559  if (remove_parent) {
561  }
562 
563  Range meshsets;
564  CHKERR get_moab().get_entities_by_type(0, MBENTITYSET, meshsets, true);
565  for (auto m : meshsets) {
566  CHKERR get_moab().remove_entities(m, ents);
567 
568  }
569 
570  rval = get_moab().delete_entities(ents);
571  if (rval != MB_SUCCESS) {
573  if (verb == QUIET) {
574  MOFEM_LOG("SELF", Sev::noisy) << "Problem deleting:\n" << ents;
575  } else {
576  MOFEM_LOG("SELF", Sev::warning) << "Problem deleting:\n" << ents;
577  }
578  MOFEM_LOG_CHANNEL("WORLD");
579  MOFEM_LOG_TAG("WORLD", "DeleteCore");
580  if (!(mf & MF_NOT_THROW)) {
581  CHK_MOAB_THROW(rval, "Can not delete entities");
582  } else {
583  rval = MB_SUCCESS;
584  }
585  }
586 
587  MOFEM_LOG_C("SELF", Sev::noisy, "Nb. of deleted entities %d", ents.size());
588 
590 }

◆ delete_field()

MoFEMErrorCode MoFEM::Core::delete_field ( const std::string  name,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Delete field.

Parameters
namefield name
verbverbosity level
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 609 of file DeleteCore.cpp.

609  {
611  auto &f = fIelds.get<FieldName_mi_tag>();
612  auto mit = f.find(name);
613  if (mit == f.end()) {
614  SETERRQ1(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
615  "Finite element <%s> not found", name.c_str());
616  }
617  EntityHandle meshset = mit->get()->getMeshset();
618  Range ents;
619  CHKERR get_moab().get_entities_by_handle(meshset, ents, false);
620  CHKERR remove_ents_from_field(name, ents, verb);
621  CHKERR get_moab().tag_delete((*mit)->th_FieldDataVerts);
622  CHKERR get_moab().tag_delete((*mit)->th_FieldData);
623  CHKERR get_moab().tag_delete((*mit)->th_AppOrder);
624  f.erase(mit);
625  CHKERR get_moab().delete_entities(&meshset, 1);
627 }

◆ delete_finite_element()

MoFEMErrorCode MoFEM::Core::delete_finite_element ( const std::string  name,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

delete finite element from mofem database

Implements MoFEM::CoreInterface.

Definition at line 592 of file DeleteCore.cpp.

592  {
594  auto &fe = finiteElements.get<FiniteElement_name_mi_tag>();
595  auto mit = fe.find(name);
596  if (mit == fe.end()) {
597  SETERRQ1(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
598  "Finite element <%s> not found", name.c_str());
599  }
600  EntityHandle meshset = mit->get()->getMeshset();
601  Range ents;
602  CHKERR get_moab().get_entities_by_handle(meshset, ents, false);
603  CHKERR remove_ents_from_finite_element(name, ents, verb);
604  fe.erase(mit);
605  CHKERR get_moab().delete_entities(&meshset, 1);
607 }

◆ delete_problem()

MoFEMErrorCode MoFEM::Core::delete_problem ( const std::string  name)
protectedvirtual

Delete problem.

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.

Implements MoFEM::CoreInterface.

Definition at line 108 of file ProblemsCore.cpp.

108  {
110  auto p_miit = pRoblems.get<Problem_mi_tag>().find(name);
111  if (p_miit == pRoblems.get<Problem_mi_tag>().end()) {
112  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "no such problem like < %s >",
113  name.c_str());
114  }
115  const EntityHandle meshset = p_miit->meshset;
116  pRoblems.get<Problem_mi_tag>().erase(p_miit);
117  CHKERR get_moab().delete_entities(&meshset, 1);
119 }

◆ Finalize()

MoFEMErrorCode MoFEM::Core::Finalize ( )
static

Checks for options to be called at the conclusion of the program.

MPI_Finalize() is called only if the user had not called MPI_Init() before calling Initialize.

Note
This function calls PetscInitialize, for more details see http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Sys/PetscFinalize.html
Returns
MoFEMErrorCode
Examples
add_blockset.cpp, add_cubit_meshsets.cpp, adolc_plasticity.cpp, analytical_nonlinear_poisson.cpp, analytical_poisson.cpp, analytical_poisson_field_split.cpp, approx_sphere.cpp, bernstein_bezier_generate_base.cpp, bone_adaptation.cpp, boundary_marker.cpp, build_large_problem.cpp, build_problems.cpp, cell_forces.cpp, child_and_parent.cpp, continuity_check_on_contact_prism_side_ele.cpp, continuity_check_on_skeleton_3d.cpp, continuity_check_on_skeleton_with_simple_2d_for_h1.cpp, continuity_check_on_skeleton_with_simple_2d_for_hcurl.cpp, continuity_check_on_skeleton_with_simple_2d_for_hdiv.cpp, cubit_bc_test.cpp, delete_ho_nodes.cpp, dg_projection.cpp, dm_build_partitioned_mesh.cpp, dm_create_subdm.cpp, dm_partitioned_no_field.cpp, dynamic_first_order_con_law.cpp, edge_and_bubble_shape_functions_on_quad.cpp, eigen_elastic.cpp, elasticity.cpp, elasticity_mixed_formulation.cpp, ep.cpp, field_blas.cpp, field_evaluator.cpp, field_to_vertices.cpp, forces_and_sources_testing_edge_element.cpp, forces_and_sources_testing_flat_prism_element.cpp, forces_and_sources_testing_users_base.cpp, free_surface.cpp, gauss_points_on_outer_product.cpp, hanging_node_approx.cpp, hcurl_check_approx_in_2d.cpp, hcurl_curl_operator.cpp, hcurl_divergence_operator_2d.cpp, hdiv_divergence_operator.cpp, heat_equation.cpp, heat_method.cpp, hello_world.cpp, helmholtz.cpp, hertz_surface.cpp, higher_derivatives.cpp, level_set.cpp, log.cpp, loop_entities.cpp, lorentz_force.cpp, magnetostatic.cpp, matrix_function.cpp, mesh_cut.cpp, mesh_insert_interface_atom.cpp, mesh_smoothing.cpp, meshset_to_vtk.cpp, minimal_surface_area.cpp, mixed_poisson.cpp, mortar_contact.cpp, mortar_contact_thermal.cpp, navier_stokes.cpp, node_merge.cpp, nonlinear_dynamics.cpp, nonlinear_elastic.cpp, operators_tests.cpp, partition_mesh.cpp, petsc_smart_ptr_objects.cpp, phase.cpp, photon_diffusion.cpp, plastic.cpp, plate.cpp, plot_base.cpp, poisson_2d_dis_galerkin.cpp, poisson_2d_homogeneous.cpp, prism_elements_from_surface.cpp, prism_polynomial_approximation.cpp, quad_polynomial_approximation.cpp, reaction_diffusion.cpp, remove_entities_from_problem.cpp, remove_entities_from_problem_not_partitioned.cpp, scalar_check_approximation.cpp, schur_test_diag_mat.cpp, seepage.cpp, shallow_wave.cpp, simple_contact.cpp, simple_contact_thermal.cpp, simple_elasticity.cpp, simple_interface.cpp, simple_l2_only.cpp, split_sideset.cpp, tensor_divergence_operator.cpp, test_broken_space.cpp, test_cache_on_entities.cpp, test_jacobian_of_simple_contact_element.cpp, testing_jacobian_of_hook_element.cpp, testing_jacobian_of_hook_scaled_with_density_element.cpp, thermo_elastic.cpp, unsaturated_transport.cpp, wave_equation.cpp, and wavy_surface.cpp.

Definition at line 112 of file Core.cpp.

112  {
113  if (isGloballyInitialised) {
114  PetscPopErrorHandler();
115  isGloballyInitialised = false;
116 
117  if (isInitialized == PETSC_FALSE) {
118  PetscBool is_finalized;
119  PetscFinalized(&is_finalized);
120  if (!is_finalized)
121  PetscFinalize();
122  }
123 
124  if (!mpiInitialised) {
125  int mpi_finalized;
126  MPI_Finalized(&mpi_finalized);
127  if (!mpi_finalized)
128  MPI_Finalize();
129  }
130  }
131 
132  return 0;
133 }

◆ get_basic_entity_data_ptr()

boost::shared_ptr<BasicEntityData>& MoFEM::CoreTmp< 0 >::get_basic_entity_data_ptr ( )
inlineprotectedvirtual

Get pointer to basic entity data.

This structure keeps data like tags handlers and other data used to construct mofem entities, dofs and finite elements.

Implements MoFEM::CoreInterface.

Definition at line 290 of file Core.hpp.

290  {
291  return basicEntityDataPtr;
292  }

◆ get_comm()

MPI_Comm& MoFEM::CoreTmp< 0 >::get_comm ( ) const
inlineprotectedvirtual
Returns
return communicator

Implements MoFEM::CoreInterface.

Definition at line 1013 of file Core.hpp.

1013 { return mofemComm; }

◆ get_comm_rank()

int MoFEM::CoreTmp< 0 >::get_comm_rank ( ) const
inlineprotectedvirtual
Returns
return communicator rank/processor

Implements MoFEM::CoreInterface.

Definition at line 1023 of file Core.hpp.

1023 { return rAnk; }

◆ get_comm_size()

int MoFEM::CoreTmp< 0 >::get_comm_size ( ) const
inlineprotectedvirtual
Returns
return communicator size

Implements MoFEM::CoreInterface.

Definition at line 1018 of file Core.hpp.

1018 { return sIze; }

◆ get_dofs() [1/2]

const DofEntity_multiIndex * MoFEM::Core::get_dofs ( ) const
protectedvirtual

Get the dofs object.

Returns
const DofEntity_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 890 of file Core.cpp.

890 { return &dofsField; }

◆ get_dofs() [2/2]

MoFEMErrorCode MoFEM::Core::get_dofs ( const DofEntity_multiIndex **  dofs_ptr) const
protectedvirtual

Get dofs multi index.

Implements MoFEM::CoreInterface.

Definition at line 829 of file Core.cpp.

829  {
831  *dofs_ptr = &dofsField;
833 }

◆ get_dofs_by_name_and_ent_begin()

DofEntityByUId::iterator MoFEM::Core::get_dofs_by_name_and_ent_begin ( const std::string &  field_name,
const EntityHandle  ent 
) const
protectedvirtual

get begin iterator of filed dofs of given name and ent(instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,ENT,IT)

for(IT_GET_DOFS_FIELD_BY_NAME_AND_ENT_FOR_LOOP(MFIELD,NAME,ENT,IT)) { ... }

Parameters
field_name

Implements MoFEM::CoreInterface.

Definition at line 1357 of file FieldCore.cpp.

1358  {
1359  return dofsField.get<Unique_mi_tag>().lower_bound(
1361  ent));
1362 }

◆ get_dofs_by_name_and_ent_end()

DofEntityByUId::iterator MoFEM::Core::get_dofs_by_name_and_ent_end ( const std::string &  field_name,
const EntityHandle  ent 
) const
protectedvirtual

get begin iterator of filed dofs of given name and ent (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,ENT,IT)

for(IT_GET_DOFS_FIELD_BY_NAME_AND_ENT_FOR_LOOP(MFIELD,NAME,ENT,IT)) { ... }

Parameters
field_name

Implements MoFEM::CoreInterface.

Definition at line 1364 of file FieldCore.cpp.

1365  {
1366  return dofsField.get<Unique_mi_tag>().upper_bound(
1368  ent));
1369 }

◆ get_dofs_by_name_and_type_begin()

DofEntityByUId::iterator MoFEM::Core::get_dofs_by_name_and_type_begin ( const std::string &  field_name,
const EntityType  type 
) const
protectedvirtual

get begin iterator of filed dofs of given name and ent type (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,TYPE,IT)

for(IT_GET_DOFS_FIELD_BY_NAME_AND_TYPE_FOR_LOOP(MFIELD,NAME,TYPE,IT)) { ... }

Parameters
field_name

Implements MoFEM::CoreInterface.

Definition at line 1371 of file FieldCore.cpp.

1372  {
1373  return dofsField.get<Unique_mi_tag>().lower_bound(
1376 }

◆ get_dofs_by_name_and_type_end()

DofEntityByUId::iterator MoFEM::Core::get_dofs_by_name_and_type_end ( const std::string &  field_name,
const EntityType  type 
) const
protectedvirtual

get begin iterator of filed dofs of given name end ent type(instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,TYPE,IT)

for(IT_GET_DOFS_FIELD_BY_NAME_AND_TYPE_FOR_LOOP(MFIELD,NAME,TYPE,IT)) { ... }

Parameters
field_name

Implements MoFEM::CoreInterface.

Definition at line 1378 of file FieldCore.cpp.

1379  {
1380  return dofsField.get<Unique_mi_tag>().upper_bound(
1383 }

◆ get_dofs_by_name_begin()

DofEntityByUId::iterator MoFEM::Core::get_dofs_by_name_begin ( const std::string &  field_name) const
protectedvirtual

get begin iterator of filed dofs of given name (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)

for(IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)) { ... }

Parameters
field_name

Implements MoFEM::CoreInterface.

Definition at line 1347 of file FieldCore.cpp.

1347  {
1348  return dofsField.get<Unique_mi_tag>().lower_bound(
1350 }

◆ get_dofs_by_name_end()

DofEntityByUId::iterator MoFEM::Core::get_dofs_by_name_end ( const std::string &  field_name) const
protectedvirtual

get begin iterator of filed dofs of given name (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)

for(IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)) { ... }

Parameters
field_name

Implements MoFEM::CoreInterface.

Definition at line 1352 of file FieldCore.cpp.

1352  {
1353  return dofsField.get<Unique_mi_tag>().upper_bound(
1355 }

◆ get_ent_field_by_name_begin()

FieldEntityByUId::iterator MoFEM::Core::get_ent_field_by_name_begin ( const std::string &  field_name) const
protectedvirtual

get begin iterator of filed ents of given name (instead you can use IT_GET_ENT_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)

for(IT_GET_ENT_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)) { ... }

Parameters
field_name

Implements MoFEM::CoreInterface.

Definition at line 1337 of file FieldCore.cpp.

1337  {
1338  return entsFields.get<Unique_mi_tag>().lower_bound(
1340 }

◆ get_ent_field_by_name_end()

FieldEntityByUId::iterator MoFEM::Core::get_ent_field_by_name_end ( const std::string &  field_name) const
protectedvirtual

get begin iterator of filed dofs of given name (instead you can use IT_GET_ENT_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)

for(IT_GET_ENT_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)) { ... }

Parameters
field_name

Implements MoFEM::CoreInterface.

Definition at line 1342 of file FieldCore.cpp.

1342  {
1343  return entsFields.get<Unique_mi_tag>().upper_bound(
1345 }

◆ get_ents_elements_adjacency() [1/2]

const FieldEntityEntFiniteElementAdjacencyMap_multiIndex * MoFEM::Core::get_ents_elements_adjacency ( ) const
protectedvirtual

Get the dofs elements adjacency object.

Returns
const FieldEntityEntFiniteElementAdjacencyMap_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 870 of file Core.cpp.

870  {
871  return &entFEAdjacencies;
872 }

◆ get_ents_elements_adjacency() [2/2]

MoFEMErrorCode MoFEM::Core::get_ents_elements_adjacency ( const FieldEntityEntFiniteElementAdjacencyMap_multiIndex **  dofs_elements_adjacency) const
protectedvirtual

Get the dofs elements adjacency object.

Parameters
dofs_elements_adjacency
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 861 of file Core.cpp.

863  {
865  *dofs_elements_adjacency = &entFEAdjacencies;
867 }

◆ get_ents_finite_elements() [1/2]

const EntFiniteElement_multiIndex * MoFEM::Core::get_ents_finite_elements ( ) const
protectedvirtual

Get the ents finite elements object.

Returns
const EntFiniteElement_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 884 of file Core.cpp.

884  {
885  return &entsFiniteElements;
886 }

◆ get_ents_finite_elements() [2/2]

MoFEMErrorCode MoFEM::Core::get_ents_finite_elements ( const EntFiniteElement_multiIndex **  fe_ent_ptr) const
protectedvirtual

Get entities finite elements multi-index.

Implements MoFEM::CoreInterface.

Definition at line 842 of file Core.cpp.

843  {
845  *fe_ent_ptr = &entsFiniteElements;
847 }

◆ get_fe_by_name_begin()

EntFiniteElement_multiIndex::index< Unique_mi_tag >::type::iterator MoFEM::Core::get_fe_by_name_begin ( const std::string &  fe_name) const
protectedvirtual

get begin iterator of finite elements of given name (instead you can use IT_GET_FES_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)

for(IT_GET_FES_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)) { ... }

Parameters
fe_name

Implements MoFEM::CoreInterface.

Definition at line 836 of file FECore.cpp.

836  {
837  auto miit = finiteElements.get<FiniteElement_name_mi_tag>().find(fe_name);
838  if (miit != finiteElements.get<FiniteElement_name_mi_tag>().end()) {
839  return entsFiniteElements.get<Unique_mi_tag>().lower_bound(
840  EntFiniteElement::getLocalUniqueIdCalculate(0, (*miit)->getFEUId()));
841  } else {
842  return entsFiniteElements.get<Unique_mi_tag>().end();
843  }
844 }

◆ get_fe_by_name_end()

EntFiniteElement_multiIndex::index< Unique_mi_tag >::type::iterator MoFEM::Core::get_fe_by_name_end ( const std::string &  fe_name) const
protectedvirtual

get end iterator of finite elements of given name (instead you can use IT_GET_FES_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)

for(IT_GET_FES_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)) { ... }

Parameters
fe_name

Implements MoFEM::CoreInterface.

Definition at line 847 of file FECore.cpp.

847  {
848  auto miit = finiteElements.get<FiniteElement_name_mi_tag>().find(fe_name);
849  if (miit != finiteElements.get<FiniteElement_name_mi_tag>().end()) {
850  return entsFiniteElements.get<Unique_mi_tag>().upper_bound(
852  get_id_for_max_type<MBENTITYSET>(), (*miit)->getFEUId()));
853  } else {
854  return entsFiniteElements.get<Unique_mi_tag>().end();
855  }
856 }

◆ get_field_bit_number()

FieldBitNumber MoFEM::Core::get_field_bit_number ( const std::string  name) const
protectedvirtual

get field bit number

Parameters
nameof field Example:
auto field_number = mField.get_field_bit_number("DISPLACEMENT");

Implements MoFEM::CoreInterface.

Definition at line 28 of file FieldCore.cpp.

28  {
29  auto &set = fIelds.get<FieldName_mi_tag>();
30  auto miit = set.find(name);
31  if (miit == set.end())
32  THROW_MESSAGE("field < " + name +
33  " > not in database (top tip: check spelling)");
34  return (*miit)->getBitNumber();
35 }

◆ get_field_entities_by_dimension()

MoFEMErrorCode MoFEM::Core::get_field_entities_by_dimension ( const std::string  name,
int  dim,
Range ents 
) const
protectedvirtual

get entities in the field by dimension

Parameters
namefield name
dimdim
entsents
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 81 of file FieldCore.cpp.

83  {
84 
86  EntityHandle meshset = get_field_meshset(name);
87  CHKERR get_moab().get_entities_by_dimension(meshset, dim, ents, true);
89 }

◆ get_field_entities_by_handle()

MoFEMErrorCode MoFEM::Core::get_field_entities_by_handle ( const std::string  name,
Range ents 
) const
protectedvirtual

get entities in the field by handle

Parameters
namefield name
entsents
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 100 of file FieldCore.cpp.

101  {
103  EntityHandle meshset = get_field_meshset(name);
104  CHKERR get_moab().get_entities_by_handle(meshset, ents, true);
106 }

◆ get_field_entities_by_type()

MoFEMErrorCode MoFEM::Core::get_field_entities_by_type ( const std::string  name,
EntityType  type,
Range ents 
) const
protectedvirtual

get entities in the field by type

Parameters
namefield name
typeentity type
entsents
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 91 of file FieldCore.cpp.

93  {
95  EntityHandle meshset = get_field_meshset(name);
96  CHKERR get_moab().get_entities_by_type(meshset, type, ents, true);
98 }

◆ get_field_ents() [1/2]

const FieldEntity_multiIndex * MoFEM::Core::get_field_ents ( ) const
protectedvirtual

Get the field ents object.

Returns
const FieldEntity_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 887 of file Core.cpp.

887  {
888  return &entsFields;
889 }

◆ get_field_ents() [2/2]

MoFEMErrorCode MoFEM::Core::get_field_ents ( const FieldEntity_multiIndex **  field_ents) const
protectedvirtual

Get field multi index.

Implements MoFEM::CoreInterface.

Definition at line 824 of file Core.cpp.

824  {
826  *field_ents = &entsFields;
828 }

◆ get_field_id()

BitFieldId MoFEM::Core::get_field_id ( const std::string &  name) const
protectedvirtual

Get field Id.

Parameters
nameof field
Returns
BitFieldId

Implements MoFEM::CoreInterface.

Definition at line 18 of file FieldCore.cpp.

18  {
19  auto &set = fIelds.get<FieldName_mi_tag>();
20  auto miit = set.find(name);
21  if (miit == set.end()) {
22  THROW_MESSAGE("field < " + name +
23  " > not in database (top tip: check spelling)");
24  }
25  return (*miit)->getId();
26 }

◆ get_field_meshset() [1/2]

EntityHandle MoFEM::Core::get_field_meshset ( const BitFieldId  id) const
protected

Definition at line 45 of file FieldCore.cpp.

45  {
46  auto &set = fIelds.get<BitFieldId_mi_tag>();
47  auto miit = set.find(id);
48  if (miit == set.end())
49  THROW_MESSAGE("field not in database (top tip: check spelling)");
50  return (*miit)->meshSet;
51 }

◆ get_field_meshset() [2/2]

EntityHandle MoFEM::Core::get_field_meshset ( const std::string  name) const
protectedvirtual

get field meshset

Parameters
nameof Field Example:
EntityHandle disp_files_meshset = mField.get_field_meshset("DISPLACEMENT");

Implements MoFEM::CoreInterface.

Definition at line 53 of file FieldCore.cpp.

53  {
54  return get_field_meshset(get_field_id(name));
55 }

◆ get_field_name()

std::string MoFEM::Core::get_field_name ( const BitFieldId  id) const
protectedvirtual

get field name from id

Parameters
id
Returns
std::string

Implements MoFEM::CoreInterface.

Definition at line 37 of file FieldCore.cpp.

37  {
38  auto &set = fIelds.get<BitFieldId_mi_tag>();
39  auto miit = set.find(id);
40  if (miit == set.end())
41  THROW_MESSAGE("field not in database (top tip: check spelling)");
42  return (*miit)->getName();
43 }

◆ get_field_structure()

const Field * MoFEM::Core::get_field_structure ( const std::string &  name,
enum MoFEMTypes  bh = MF_EXIST 
) const
protectedvirtual

get field structure

If field is not found throw error if bh == MF_EXIST, or return nullptr if bh == MF_ZERO, i.e. otherwise

Parameters
namefield name
bhcontrols behaviour
Returns
const Field*

Implements MoFEM::CoreInterface.

Definition at line 65 of file FieldCore.cpp.

66  {
67  auto miit = fIelds.get<FieldName_mi_tag>().find(name);
68  if (miit == fIelds.get<FieldName_mi_tag>().end()) {
69  if (bh == MF_EXIST)
70  throw MoFEMException(
72  std::string("field < " + name +
73  " > not in database (top tip: check spelling)")
74  .c_str());
75  else
76  return nullptr;
77  }
78  return miit->get();
79 }

◆ get_fields() [1/2]

const Field_multiIndex * MoFEM::Core::get_fields ( ) const
protectedvirtual

Get the fields object.

Returns
const Field_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 874 of file Core.cpp.

874 { return &fIelds; }

◆ get_fields() [2/2]

MoFEMErrorCode MoFEM::Core::get_fields ( const Field_multiIndex **  fields_ptr) const
protectedvirtual

Get fields multi-index from database.

Implements MoFEM::CoreInterface.

Definition at line 782 of file Core.cpp.

782  {
784  *fields_ptr = &fIelds;
786 }

◆ get_finite_element_entities_by_dimension()

MoFEMErrorCode MoFEM::Core::get_finite_element_entities_by_dimension ( const std::string  name,
int  dim,
Range ents 
) const
protectedvirtual

get entities in the finite element by dimension

Parameters
namefinite element name
dimdim
entsents
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 286 of file FECore.cpp.

287  {
288 
290 
292  CHKERR get_moab().get_entities_by_dimension(meshset, dim, ents, true);
294 }

◆ get_finite_element_entities_by_handle()

MoFEMErrorCode MoFEM::Core::get_finite_element_entities_by_handle ( const std::string  name,
Range ents 
) const
protectedvirtual

get entities in the finite element by handle

Parameters
namefinite element name
entsents
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 309 of file FECore.cpp.

310  {
311 
313 
315  CHKERR get_moab().get_entities_by_handle(meshset, ents, true);
316 
318 }

◆ get_finite_element_entities_by_type()

MoFEMErrorCode MoFEM::Core::get_finite_element_entities_by_type ( const std::string  name,
EntityType  type,
Range ents 
) const
protectedvirtual

get entities in the finite element by type

Parameters
namefinite element name
typeentity type
entsents
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 296 of file FECore.cpp.

298  {
299 
301 
303  CHKERR get_moab().get_entities_by_type(meshset, type, ents, true);
304 
306 }

◆ get_finite_element_meshset() [1/2]

EntityHandle MoFEM::Core::get_finite_element_meshset ( const BitFEId  id) const
protected

Definition at line 273 of file FECore.cpp.

273  {
274  auto &fe_by_id = finiteElements.get<BitFEId_mi_tag>();
275  auto miit = fe_by_id.find(id);
276  if (miit == fe_by_id.end())
277  THROW_MESSAGE("finite element not found");
278  return (*miit)->meshset;
279 }

◆ get_finite_element_meshset() [2/2]

EntityHandle MoFEM::Core::get_finite_element_meshset ( const std::string  name) const
protectedvirtual

get finite element meshset

Implements MoFEM::CoreInterface.

Definition at line 281 of file FECore.cpp.

281  {
283 }

◆ get_finite_element_structure()

const FiniteElement * MoFEM::Core::get_finite_element_structure ( const std::string &  name,
enum MoFEMTypes  bh = MF_EXCL 
) const
protectedvirtual

get finite element struture

If finite element is not found throw error if bh == MF_EXIST, or return nullptr if bh == MF_ZERO, i.e. otherwise

Parameters
name
bh
Returns
FiniteElement*

Implements MoFEM::CoreInterface.

Definition at line 18 of file FECore.cpp.

19  {
20  auto miit = finiteElements.get<FiniteElement_name_mi_tag>().find(name);
21  if (miit == finiteElements.get<FiniteElement_name_mi_tag>().end()) {
22  if (bh == MF_EXIST) {
23  throw MoFEMException(
25  std::string("finite element < " + name +
26  " > not in database (top tip: check spelling)")
27  .c_str());
28  } else {
29  return nullptr;
30  }
31  }
32  return miit->get();
33 }

◆ get_finite_elements() [1/2]

const FiniteElement_multiIndex * MoFEM::Core::get_finite_elements ( ) const
protectedvirtual

Get the finite elements object.

Returns
const FiniteElement_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 881 of file Core.cpp.

881  {
882  return &finiteElements;
883 }

◆ get_finite_elements() [2/2]

MoFEMErrorCode MoFEM::Core::get_finite_elements ( const FiniteElement_multiIndex **  fe_ptr) const
protectedvirtual

Get finite elements multi-index.

Implements MoFEM::CoreInterface.

Definition at line 836 of file Core.cpp.

836  {
838  *fe_ptr = &finiteElements;
840 }

◆ get_meshsets_manager() [1/2]

MeshsetsManager& MoFEM::CoreTmp< 0 >::get_meshsets_manager ( )
inlineprotectedvirtual

get MeshsetsManager pointer

Implements MoFEM::CoreInterface.

Definition at line 361 of file Core.hpp.

361  {
362  return *get_meshsets_manager_ptr();
363  }

◆ get_meshsets_manager() [2/2]

const MeshsetsManager& MoFEM::CoreTmp< 0 >::get_meshsets_manager ( ) const
inlineprotectedvirtual

get MeshsetsManager pointer

Implements MoFEM::CoreInterface.

Definition at line 364 of file Core.hpp.

364  {
365  return *get_meshsets_manager_ptr();
366  }

◆ get_meshsets_manager_ptr() [1/2]

const MeshsetsManager * MoFEM::Core::get_meshsets_manager_ptr ( )
protectedvirtual

get MeshsetsManager pointer

Implements MoFEM::CoreInterface.

Definition at line 849 of file Core.cpp.

849  {
850  MeshsetsManager *meshsets_manager_ptr;
851  getInterface(meshsets_manager_ptr);
852  return meshsets_manager_ptr;
853 }

◆ get_meshsets_manager_ptr() [2/2]

const MeshsetsManager* MoFEM::CoreTmp< 0 >::get_meshsets_manager_ptr ( ) const
protectedvirtual

get MeshsetsManager pointer

Implements MoFEM::CoreInterface.

◆ get_moab() [1/2]

moab::Interface& MoFEM::CoreTmp< 0 >::get_moab ( )
inlineprotectedvirtual

get moab instance

Implements MoFEM::CoreInterface.

Definition at line 322 of file Core.hpp.

322 { return moab; }

◆ get_moab() [2/2]

const moab::Interface& MoFEM::CoreTmp< 0 >::get_moab ( ) const
inlineprotectedvirtual

get moab instance interface

Implements MoFEM::CoreInterface.

Definition at line 323 of file Core.hpp.

323 { return moab; }

◆ get_problem() [1/2]

MoFEMErrorCode MoFEM::Core::get_problem ( const std::string &  problem_name,
const Problem **  problem_ptr 
) const
protectedvirtual

Get problem database (data structure)

Implements MoFEM::CoreInterface.

Definition at line 801 of file Core.cpp.

802  {
805  const ProblemsByName &problems = pRoblems.get<Problem_mi_tag>();
806  ProblemsByName::iterator p_miit = problems.find(problem_name);
807  if (p_miit == problems.end()) {
808  SETERRQ1(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
809  "problem < %s > not found, (top tip: check spelling)",
810  problem_name.c_str());
811  }
812  *problem_ptr = &*p_miit;
814 }

◆ get_problem() [2/2]

const Problem * MoFEM::Core::get_problem ( const std::string  problem_name) const
protectedvirtual

Get the problem object.

Parameters
problem_name
Returns
const Problem*

Implements MoFEM::CoreInterface.

Definition at line 891 of file Core.cpp.

891  {
892  const Problem *prb;
893  CHK_THROW_MESSAGE(get_problem(problem_name, &prb),
894  "Problem of given name not found");
895  return prb;
896 }

◆ get_problem_finite_elements_entities()

MoFEMErrorCode MoFEM::Core::get_problem_finite_elements_entities ( const std::string  name,
const std::string &  fe_name,
const EntityHandle  meshset 
)
protectedvirtual

add finite elements to the meshset

Parameters
nameis problem name
fe_name
meshset

Implements MoFEM::CoreInterface.

Definition at line 911 of file FECore.cpp.

913  {
915  auto &prb = pRoblems.get<Problem_mi_tag>();
916  auto p_miit = prb.find(problem_name);
917  if (p_miit == prb.end())
918  SETERRQ1(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
919  "No such problem like < %s >", problem_name.c_str());
920 
921  auto fe_miit = finiteElements.get<FiniteElement_name_mi_tag>().find(fe_name);
922  if (fe_miit != finiteElements.get<FiniteElement_name_mi_tag>().end()) {
923  auto miit =
924  p_miit->numeredFiniteElementsPtr->get<Unique_mi_tag>().lower_bound(
926  0, (*fe_miit)->getFEUId()));
927  auto hi_miit =
928  p_miit->numeredFiniteElementsPtr->get<Unique_mi_tag>().upper_bound(
930  get_id_for_max_type<MBENTITYSET>(), (*fe_miit)->getFEUId()));
931 
932  if (miit != hi_miit) {
933  std::vector<EntityHandle> ents;
934  ents.reserve(std::distance(miit, hi_miit));
935  for (; miit != hi_miit; ++miit)
936  ents.push_back((*miit)->getEnt());
937  int part = (*miit)->getPart();
938  CHKERR get_moab().tag_clear_data(th_Part, &*ents.begin(), ents.size(),
939  &part);
940  CHKERR get_moab().add_entities(meshset, &*ents.begin(), ents.size());
941  }
942  }
943 
945 }

◆ get_problems() [1/2]

const Problem_multiIndex * MoFEM::Core::get_problems ( ) const
protectedvirtual

Get the problems object.

Returns
const Problem_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 897 of file Core.cpp.

897 { return &pRoblems; }

◆ get_problems() [2/2]

MoFEMErrorCode MoFEM::Core::get_problems ( const Problem_multiIndex **  problems_ptr) const
protectedvirtual

Get pointer to problems multi-index.

Implements MoFEM::CoreInterface.

Definition at line 817 of file Core.cpp.

817  {
819  *problems_ptr = &pRoblems;
821 }

◆ get_ref_ents() [1/2]

const RefEntity_multiIndex * MoFEM::Core::get_ref_ents ( ) const
protectedvirtual

Get the ref ents object.

Returns
const RefEntity_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 875 of file Core.cpp.

875  {
876  return &refinedEntities;
877 }

◆ get_ref_ents() [2/2]

MoFEMErrorCode MoFEM::Core::get_ref_ents ( const RefEntity_multiIndex **  refined_ents_ptr) const
protectedvirtual

Get ref entities multi-index from database.

Implements MoFEM::CoreInterface.

Definition at line 789 of file Core.cpp.

789  {
791  *refined_entities_ptr = &refinedEntities;
793 }

◆ get_ref_finite_elements() [1/2]

const RefElement_multiIndex * MoFEM::Core::get_ref_finite_elements ( ) const
protectedvirtual

Get the ref finite elements object.

Returns
const RefElement_multiIndex*

Implements MoFEM::CoreInterface.

Definition at line 878 of file Core.cpp.

878  {
879  return &refinedFiniteElements;
880 }

◆ get_ref_finite_elements() [2/2]

MoFEMErrorCode MoFEM::Core::get_ref_finite_elements ( const RefElement_multiIndex **  refined_finite_elements_ptr) const
protectedvirtual

Get ref finite elements multi-index form database.

Implements MoFEM::CoreInterface.

Definition at line 794 of file Core.cpp.

795  {
797  *refined_finite_elements_ptr = &refinedFiniteElements;
799 }

◆ get_th_RefBitEdge()

Tag MoFEM::CoreTmp< 0 >::get_th_RefBitEdge ( ) const
inline

Definition at line 199 of file Core.hpp.

199 { return th_RefBitEdge; }

◆ get_th_RefBitLevel()

Tag MoFEM::CoreTmp< 0 >::get_th_RefBitLevel ( ) const
inline

Definition at line 198 of file Core.hpp.

198 { return th_RefBitLevel; }

◆ get_th_RefParentHandle()

Tag MoFEM::CoreTmp< 0 >::get_th_RefParentHandle ( ) const
inline

Definition at line 197 of file Core.hpp.

197 { return th_RefParentHandle; }

◆ getBitFEId()

BitFEId MoFEM::Core::getBitFEId ( const std::string &  fe_name) const
protected

Get field Id.

Parameters
namefield name
Returns
field id

Definition at line 255 of file FECore.cpp.

255  {
256  auto &fe_by_id = finiteElements.get<FiniteElement_name_mi_tag>();
257  auto miit = fe_by_id.find(fe_name);
258  if (miit == fe_by_id.end())
260  ("finite element < " + fe_name + " > not found (top tip: check spelling)")
261  .c_str());
262  return (*miit)->getId();
263 }

◆ getBitFEIdName()

std::string MoFEM::Core::getBitFEIdName ( const BitFEId  id) const
protected

Get field name.

Parameters
idfield id
Returns
field name

Definition at line 265 of file FECore.cpp.

265  {
266  auto &fe_by_id = finiteElements.get<BitFEId_mi_tag>();
267  auto miit = fe_by_id.find(id);
268  if (miit == fe_by_id.end())
269  THROW_MESSAGE("finite element not found");
270  return (*miit)->getName();
271 }

◆ getBitProblemId()

BitProblemId MoFEM::Core::getBitProblemId ( const std::string &  name) const
protected

Definition at line 121 of file ProblemsCore.cpp.

121  {
122  auto p_miit = pRoblems.get<Problem_mi_tag>().find(name);
123  if (p_miit == pRoblems.get<Problem_mi_tag>().end()) {
124  THROW_MESSAGE("no such problem like " + name + " >");
125  }
126  return p_miit->getId();
127 }

◆ getBuildMoFEM()

int& MoFEM::CoreTmp< 0 >::getBuildMoFEM ( ) const
inline

Get flags/semaphores for different stages.

Definition at line 225 of file Core.hpp.

225 { return *buildMoFEM; }

◆ getOptions()

MoFEMErrorCode MoFEM::Core::getOptions ( int  verb = DEFAULT_VERBOSITY)
protected

Get core options from command line.

Returns
MoFEMErrorCode

Definition at line 755 of file Core.cpp.

755  {
757  if (verb == -1)
758  verb = verbose;
759 
760  CHKERR PetscOptionsBegin(mofemComm, optionsPrefix.c_str(), "Mesh cut options",
761  "See MoFEM documentation");
762 
763  CHKERR PetscOptionsBool(
764  "-mofem_init_fields", "Initialise fields on construction", "",
766 
767  CHKERR PetscOptionsBool(
768  "-mofem_init_fields", "Initialise fields on construction", "",
770 
771  // TODO: Add read verbosity level
772  // TODO: Add option to initalise problems ??? - DO WE REALLY NEED THAT
773 
774  ierr = PetscOptionsEnd();
775  CHKERRG(ierr);
776 
778 }

◆ getProblemShift()

BitProblemId MoFEM::CoreTmp< 0 >::getProblemShift ( )
protected

Return unique problem Id.

Each time this function is called, it gives new unit problem Id for bit.

◆ getRefEntity()

RefEntityTmp<0> MoFEM::CoreTmp< 0 >::getRefEntity ( const EntityHandle  ent)
inline

Definition at line 86 of file Core.hpp.

86  {
87  return RefEntityTmp<0>(this->basicEntityDataPtr, ent);
88  }

◆ getTags()

MoFEMErrorCode MoFEM::Core::getTags ( int  verb = DEFAULT_VERBOSITY)
protected

Get tag handles.

Parameters
verbverbosity level
Returns
error code

Definition at line 551 of file Core.cpp.

551  {
553 
554  const EntityHandle root_meshset = get_moab().get_root_set();
555  if (root_meshset) {
556  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
557  "Root meshset should be 0");
558  }
559 
560  // Set version
561  {
562  Version version;
563  CHKERR getFileVersion(moab, version);
564  }
565 
566  // Global Variables
567  {
568 
569  auto check_tag_allocated = [](auto &rval) {
571  if (rval == MB_ALREADY_ALLOCATED)
572  rval = MB_SUCCESS;
573  else
574  CHKERRG(rval);
576  };
577 
578  // Safety nets
579  int def_bool = 0;
580  rval = get_moab().tag_get_handle("_MoFEMBuild", 1, MB_TYPE_INTEGER,
581  th_MoFEMBuild, MB_TAG_CREAT | MB_TAG_MESH,
582  &def_bool);
583  CHKERR check_tag_allocated(rval);
584 
585  CHKERR get_moab().tag_get_by_ptr(th_MoFEMBuild, &root_meshset, 1,
586  (const void **)&buildMoFEM);
587  }
588 
589  // Tags saved in vtk-files
590  {
591  const int def_part = -1;
592  CHKERR get_moab().tag_get_handle("PARTITION", 1, MB_TYPE_INTEGER, th_Part,
593  MB_TAG_CREAT | MB_TAG_SPARSE, &def_part);
594  }
595 
596  // Tags Ref
597  {
598 
599  // Fix size of bir ref level tags
601 
602  const int def_part = -1;
603  CHKERR get_moab().tag_get_handle("_MeshsetPartition", 1, MB_TYPE_INTEGER,
604  th_Part, MB_TAG_CREAT | MB_TAG_SPARSE,
605  &def_part);
606  EntityHandle def_handle = 0;
607  CHKERR get_moab().tag_get_handle("_RefParentHandle", 1, MB_TYPE_HANDLE,
609  MB_TAG_CREAT | MB_TAG_SPARSE, &def_handle);
610  BitRefLevel def_bit_level = 0;
611  CHKERR get_moab().tag_get_handle(
612  "_RefBitLevel", sizeof(BitRefLevel), MB_TYPE_OPAQUE, th_RefBitLevel,
613  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_bit_level);
614  BitRefLevel def_bit_level_mask = BitRefLevel().set();
615  CHKERR get_moab().tag_get_handle(
616  "_RefBitLevelMask", sizeof(BitRefLevel), MB_TYPE_OPAQUE,
617  th_RefBitLevel_Mask, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE,
618  &def_bit_level_mask);
619  BitRefEdges def_bit_edge = 0;
620  CHKERR get_moab().tag_get_handle(
621  "_RefBitEdge", sizeof(BitRefEdges), MB_TYPE_OPAQUE, th_RefBitEdge,
622  MB_TAG_CREAT | MB_TAG_SPARSE | MB_TAG_BYTES, &def_bit_edge);
623  }
624 
625  // Tags Field
626  {
627  const unsigned long int def_id = 0;
628  CHKERR get_moab().tag_get_handle(
629  "_FieldId", sizeof(BitFieldId), MB_TYPE_OPAQUE, th_FieldId,
630  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_id);
631  FieldSpace def_space = LASTSPACE;
632  CHKERR get_moab().tag_get_handle(
633  "_FieldSpace", sizeof(FieldSpace), MB_TYPE_OPAQUE, th_FieldSpace,
634  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_space);
635  FieldContinuity def_continuity = LASTCONTINUITY;
636  CHKERR get_moab().tag_get_handle(
637  "_FieldContinuity", sizeof(FieldContinuity), MB_TYPE_OPAQUE,
638  th_FieldContinuity, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE,
639  &def_continuity);
640  FieldApproximationBase def_base = LASTBASE;
641  CHKERR get_moab().tag_get_handle(
642  "_FieldBase", sizeof(FieldApproximationBase), MB_TYPE_OPAQUE,
643  th_FieldBase, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_base);
644  const int def_val_len = 0;
645  CHKERR get_moab().tag_get_handle(
646  "_FieldName", def_val_len, MB_TYPE_OPAQUE, th_FieldName,
647  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_VARLEN | MB_TAG_SPARSE, NULL);
648  CHKERR get_moab().tag_get_handle(
649  "_FieldName_DataNamePrefix", def_val_len, MB_TYPE_OPAQUE,
651  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_VARLEN | MB_TAG_SPARSE, NULL);
652  }
653 
654  // Tags FE
655  {
656  const unsigned long int def_id = 0;
657  const int def_val_len = 0;
658  CHKERR get_moab().tag_get_handle(
659  "_FEId", sizeof(BitFEId), MB_TYPE_OPAQUE, th_FEId,
660  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_id);
661  CHKERR get_moab().tag_get_handle(
662  "_FEName", def_val_len, MB_TYPE_OPAQUE, th_FEName,
663  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_VARLEN | MB_TAG_SPARSE, NULL);
664  CHKERR get_moab().tag_get_handle(
665  "_FEIdCol", sizeof(BitFieldId), MB_TYPE_OPAQUE, th_FEIdCol,
666  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_id);
667  CHKERR get_moab().tag_get_handle(
668  "_FEIdRow", sizeof(BitFieldId), MB_TYPE_OPAQUE, th_FEIdRow,
669  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_id);
670  CHKERR get_moab().tag_get_handle(
671  "_FEIdData", sizeof(BitFieldId), MB_TYPE_OPAQUE, th_FEIdData,
672  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_id);
673  }
674 
675  // Tags Problem
676  {
677  const unsigned long int def_id = 0;
678  const int def_val_len = 0;
679  CHKERR get_moab().tag_get_handle(
680  "_ProblemId", sizeof(BitProblemId), MB_TYPE_OPAQUE, th_ProblemId,
681  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_id);
682  CHKERR get_moab().tag_get_handle(
683  "_ProblemFEId", sizeof(BitFEId), MB_TYPE_OPAQUE, th_ProblemFEId,
684  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE, &def_id);
685  CHKERR get_moab().tag_get_handle(
686  "_ProblemName", def_val_len, MB_TYPE_OPAQUE, th_ProblemName,
687  MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_VARLEN | MB_TAG_SPARSE, NULL);
688  DofIdx def_nbdofs = 0;
689  CHKERR get_moab().tag_get_handle(
690  "_ProblemNbDofsRow", sizeof(DofIdx), MB_TYPE_OPAQUE,
691  th_ProblemNbDofsRow, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE,
692  &def_nbdofs);
693  CHKERR get_moab().tag_get_handle(
694  "_ProblemNbDofsCol", sizeof(DofIdx), MB_TYPE_OPAQUE,
695  th_ProblemNbDofsCol, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE,
696  &def_nbdofs);
697  CHKERR get_moab().tag_get_handle(
698  "_ProblemLocalNbDofsRow", sizeof(DofIdx), MB_TYPE_OPAQUE,
699  th_ProblemLocalNbDofRow, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE,
700  &def_nbdofs);
701  CHKERR get_moab().tag_get_handle(
702  "_ProblemGhostNbDofsRow", sizeof(DofIdx), MB_TYPE_OPAQUE,
703  th_ProblemGhostNbDofRow, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE,
704  &def_nbdofs);
705  CHKERR get_moab().tag_get_handle(
706  "_ProblemLocalNbDofsCol", sizeof(DofIdx), MB_TYPE_OPAQUE,
707  th_ProblemLocalNbDofCol, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE,
708  &def_nbdofs);
709  CHKERR get_moab().tag_get_handle(
710  "_ProblemGhostNbDofsCol", sizeof(DofIdx), MB_TYPE_OPAQUE,
711  th_ProblemGhostNbDofCol, MB_TAG_CREAT | MB_TAG_BYTES | MB_TAG_SPARSE,
712  &def_nbdofs);
713  }
714 
715  // Meshsets with boundary conditions and material sets
716  MeshsetsManager *meshsets_manager_ptr;
717  CHKERR getInterface(meshsets_manager_ptr);
718  CHKERR meshsets_manager_ptr->getTags(verb);
719 
720  // Series recorder
721  SeriesRecorder *series_recorder_ptr;
722  CHKERR getInterface(series_recorder_ptr);
723  CHKERR series_recorder_ptr->getTags(verb);
724 
726 }

◆ getValue()

const int MoFEM::CoreTmp< 0 >::getValue ( ) const
inlinevirtual

Get the core.

Returns
int

Implements MoFEM::CoreInterface.

Reimplemented in MoFEM::CoreTmp<-1 >.

Definition at line 85 of file Core.hpp.

85 { return value; }

◆ initialiseDatabaseFromMesh()

MoFEMErrorCode MoFEM::Core::initialiseDatabaseFromMesh ( int  verb = DEFAULT_VERBOSITY)
protected

Initialize database getting information on mesh.

Definition at line 294 of file Core.cpp.

294  {
295  MOFEM_LOG_CHANNEL("WORLD");
297  if (verb == -1)
298  verb = verbose;
299 
300  Range ref_elems_to_add;
301 
302  // Initialize database
303  Range meshsets;
304  CHKERR get_moab().get_entities_by_type(0, MBENTITYSET, meshsets, false);
305  Range special_meshsets;
306  for (auto mit : meshsets) {
307  BitFieldId field_id;
308  // Get bit id form field tag
309  CHKERR get_moab().tag_get_data(th_FieldId, &mit, 1, &field_id);
310  // Check if meshset if field meshset
311  if (field_id != 0) {
312 
313  const void *tag_name;
314  int tag_name_size;
315  CHKERR get_moab().tag_get_by_ptr(
316  th_FieldName, &mit, 1, (const void **)&tag_name, &tag_name_size);
317 
318  if (verb > QUIET)
319  MOFEM_LOG("WORLD", Sev::verbose)
320  << "Read field "
321  << boost::string_ref((char *)tag_name, tag_name_size);
322 
323  auto p = fIelds.insert(boost::make_shared<Field>(moab, mit));
324 
325  if (!p.second) {
326  // Field meshset exists, remove duplicate meshsets from other
327  // processors.
328  Range ents;
329  CHKERR get_moab().get_entities_by_handle(mit, ents, true);
330  CHKERR get_moab().add_entities((*p.first)->getMeshset(), ents);
331  CHKERR get_moab().delete_entities(&mit, 1);
332  } else {
333  special_meshsets.insert(mit);
334  }
335  }
336  // Check for finite elements
337  BitFieldId fe_id;
338  // Get bit id from fe tag
339  CHKERR get_moab().tag_get_data(th_FEId, &mit, 1, &fe_id);
340  // check if meshset is finite element meshset
341  if (fe_id != 0) {
342  std::pair<FiniteElement_multiIndex::iterator, bool> p =
343  finiteElements.insert(
344  boost::shared_ptr<FiniteElement>(new FiniteElement(moab, mit)));
345  if (verb > QUIET)
346  MOFEM_LOG("WORLD", Sev::verbose) << "Read finite element " << **p.first;
347 
348  Range ents;
349  CHKERR get_moab().get_entities_by_type(mit, MBENTITYSET, ents, false);
350  CHKERR get_moab().get_entities_by_handle(mit, ents, true);
351  ref_elems_to_add.merge(ents);
352  if (!p.second) {
353  // Finite element mesh set exist, could be created on other processor.
354  // Remove duplicate.
355  CHKERR get_moab().add_entities((*p.first)->getMeshset(), ents);
356  CHKERR get_moab().delete_entities(&mit, 1);
357  } else {
358  special_meshsets.insert(mit);
359  }
360  }
361  BitProblemId problem_id;
362  // get bit id form problem tag
363  CHKERR get_moab().tag_get_data(th_ProblemId, &mit, 1, &problem_id);
364  // check if meshset if problem meshset
365  if (problem_id != 0) {
366  std::pair<Problem_multiIndex::iterator, bool> p =
367  pRoblems.insert(Problem(moab, mit));
368  if (verb > QUIET) {
369  MOFEM_LOG("WORLD", Sev::verbose) << "Read problem " << *p.first;
370  MOFEM_LOG("WORLD", Sev::noisy)
371  << "\tBitRef " << p.first->getBitRefLevel() << " BitMask "
372  << p.first->getBitRefLevelMask();
373  }
374 
375  if (!p.second) {
376  // Problem meshset exists, could be created on other processor.
377  // Remove duplicate.
378  Range ents;
379  CHKERR get_moab().get_entities_by_handle(mit, ents, true);
380  CHKERR get_moab().get_entities_by_type(mit, MBENTITYSET, ents, true);
381  CHKERR get_moab().add_entities(p.first->meshset, ents);
382  CHKERR get_moab().delete_entities(&mit, 1);
383  } else {
384  special_meshsets.insert(mit);
385  }
386  }
387  }
388 
389  // Add entities to database
390  Range bit_ref_ents;
391  CHKERR get_moab().get_entities_by_handle(0, bit_ref_ents, false);
392  bit_ref_ents = subtract(bit_ref_ents, special_meshsets);
393  CHKERR getInterface<BitRefManager>()->filterEntitiesByRefLevel(
394  BitRefLevel().set(), BitRefLevel().set(), bit_ref_ents);
395  CHKERR getInterface<BitRefManager>()->setEntitiesBitRefLevel(bit_ref_ents);
396  CHKERR getInterface<BitRefManager>()->setElementsBitRefLevel(
397  ref_elems_to_add);
398 
399  // Build field entities
400  for (auto field : fIelds) {
401  if (field->getSpace() != NOSPACE) {
402  Range ents_of_id_meshset;
403  CHKERR get_moab().get_entities_by_handle(field->getMeshset(),
404  ents_of_id_meshset, false);
405  CHKERR set_field_order(ents_of_id_meshset, field->getId(), -1, verb);
406  }
407  }
408 
410  CHKERR build_fields(verb);
413  }
414  }
415 
416  if (verb > VERY_NOISY) {
417  list_fields();
419  list_problem();
420  }
421 
422  // Initialize interfaces
423  MeshsetsManager *m_manger_ptr;
424  CHKERR getInterface(m_manger_ptr);
425  CHKERR m_manger_ptr->initialiseDatabaseFromMesh(verb);
426  SeriesRecorder *series_recorder_ptr;
427  CHKERR getInterface(series_recorder_ptr);
428  CHKERR series_recorder_ptr->initialiseDatabaseFromMesh(verb);
429 
431 }

◆ Initialize()

MoFEMErrorCode MoFEM::Core::Initialize ( int *  argc,
char ***  args,
const char  file[],
const char  help[] 
)
static

Initializes the MoFEM database PETSc, MOAB and MPI.

Note
This function calls PetscInitialize, for more details see http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Sys/PetscInitialize.html

Example:

int main(int argc, char *argv[]) {
// Initailise MoFEM and Petsc
MoFEM::Core::Initialize(&argc, &argv, (char *)0, help);
try {
moab::Core mb_instance; // MoAB database
moab::Interface &moab = mb_instance;
MoFEM::Core core(moab); // MOFEM database
MoFEM::CoreInterface &m_field = core;
CHKERR foo(); // Call function
}
}
Parameters
argccount of number of command line arguments
argsthe command line arguments
file[optional] PETSc database file, also checks ~username/.petscrc
  • and .petscrc use NULL to not check for code specific file. Use * -skip_petscrc in the code specific file to skip the .petscrc files
help[optional] Help message to print, use NULL for no message
Returns
MoFEMErrorCode
Examples
add_blockset.cpp, add_cubit_meshsets.cpp, adolc_plasticity.cpp, analytical_nonlinear_poisson.cpp, analytical_poisson.cpp, analytical_poisson_field_split.cpp, approx_sphere.cpp, bernstein_bezier_generate_base.cpp, bone_adaptation.cpp, boundary_marker.cpp, build_large_problem.cpp, build_problems.cpp, cell_forces.cpp, child_and_parent.cpp, continuity_check_on_contact_prism_side_ele.cpp, continuity_check_on_skeleton_3d.cpp, continuity_check_on_skeleton_with_simple_2d_for_h1.cpp, continuity_check_on_skeleton_with_simple_2d_for_hcurl.cpp, continuity_check_on_skeleton_with_simple_2d_for_hdiv.cpp, cubit_bc_test.cpp, delete_ho_nodes.cpp, dg_projection.cpp, dm_build_partitioned_mesh.cpp, dm_create_subdm.cpp, dm_partitioned_no_field.cpp, dynamic_first_order_con_law.cpp, edge_and_bubble_shape_functions_on_quad.cpp, eigen_elastic.cpp, elasticity.cpp, elasticity_mixed_formulation.cpp, ep.cpp, field_blas.cpp, field_evaluator.cpp, field_to_vertices.cpp, forces_and_sources_testing_edge_element.cpp, forces_and_sources_testing_flat_prism_element.cpp, forces_and_sources_testing_users_base.cpp, free_surface.cpp, gauss_points_on_outer_product.cpp, hanging_node_approx.cpp, hcurl_check_approx_in_2d.cpp, hcurl_curl_operator.cpp, hcurl_divergence_operator_2d.cpp, hdiv_divergence_operator.cpp, heat_equation.cpp, heat_method.cpp, hello_world.cpp, helmholtz.cpp, hertz_surface.cpp, higher_derivatives.cpp, level_set.cpp, log.cpp, loop_entities.cpp, lorentz_force.cpp, magnetostatic.cpp, matrix_function.cpp, mesh_cut.cpp, mesh_insert_interface_atom.cpp, mesh_smoothing.cpp, meshset_to_vtk.cpp, minimal_surface_area.cpp, mixed_poisson.cpp, mortar_contact.cpp, mortar_contact_thermal.cpp, navier_stokes.cpp, node_merge.cpp, nonlinear_dynamics.cpp, nonlinear_elastic.cpp, operators_tests.cpp, partition_mesh.cpp, petsc_smart_ptr_objects.cpp, phase.cpp, photon_diffusion.cpp, plastic.cpp, plate.cpp, plot_base.cpp, poisson_2d_dis_galerkin.cpp, poisson_2d_homogeneous.cpp, prism_elements_from_surface.cpp, prism_polynomial_approximation.cpp, quad_polynomial_approximation.cpp, reaction_diffusion.cpp, remove_entities_from_problem.cpp, remove_entities_from_problem_not_partitioned.cpp, scalar_check_approximation.cpp, schur_test_diag_mat.cpp, seepage.cpp, shallow_wave.cpp, simple_contact.cpp, simple_contact_thermal.cpp, simple_elasticity.cpp, simple_interface.cpp, simple_l2_only.cpp, split_sideset.cpp, tensor_divergence_operator.cpp, test_broken_space.cpp, test_cache_on_entities.cpp, test_jacobian_of_simple_contact_element.cpp, testing_jacobian_of_hook_element.cpp, testing_jacobian_of_hook_scaled_with_density_element.cpp, thermo_elastic.cpp, unsaturated_transport.cpp, wave_equation.cpp, and wavy_surface.cpp.

Definition at line 72 of file Core.cpp.

73  {
74 
75  MPI_Initialized(&mpiInitialised);
76  if (!mpiInitialised)
77  MPI_Init(argc, args);
78 
79  PetscInitialized(&isInitialized);
80  if (isInitialized == PETSC_FALSE) {
81  PetscInitialize(argc, args, file, help);
82  PetscPushErrorHandler(mofem_error_handler, PETSC_NULL);
83  }
84 
85  LogManager::createDefaultSinks(MPI_COMM_WORLD);
86  PetscVFPrintf = LogManager::logPetscFPrintf;
88  isGloballyInitialised = true;
89 
90  MOFEM_LOG_CHANNEL("WORLD");
91  char petsc_version[255];
92  CHKERR PetscGetVersion(petsc_version, 255);
93  MOFEM_LOG_C("WORLD", Sev::inform, "MoFEM version %d.%d.%d (%s %s)",
94  MoFEM_VERSION_MAJOR, MoFEM_VERSION_MINOR, MoFEM_VERSION_BUILD,
95  MOAB_VERSION_STRING, petsc_version);
96  MOFEM_LOG_C("WORLD", Sev::inform, "git commit id %s", GIT_SHA1_NAME);
97 
98  auto log_time = [&](const auto perefix, auto time) {
99  MOFEM_LOG("WORLD", Sev::inform)
100  << perefix << time.date().year() << "-" << time.date().month() << "-"
101  << time.date().day() << " " << time.time_of_day().hours() << ":"
102  << time.time_of_day().minutes() << ":" << time.time_of_day().seconds();
103  };
104 
105  // Get current system time
106  log_time("Local time: ", boost::posix_time::second_clock::local_time());
107  log_time("UTC time: ", boost::posix_time::second_clock::universal_time());
108 
109  return MOFEM_SUCCESS;
110 }

◆ list_dofs_by_field_name()

MoFEMErrorCode MoFEM::Core::list_dofs_by_field_name ( const std::string &  name) const
protectedvirtual

list dofs

Implements MoFEM::CoreInterface.

Definition at line 1312 of file FieldCore.cpp.

1312  {
1314  auto dit = dofsField.get<Unique_mi_tag>().lower_bound(
1316  auto hi_dit = dofsField.get<Unique_mi_tag>().upper_bound(
1318  MOFEM_LOG("SYNC", Sev::inform) << "List DOFs:";
1319  for (; dit != hi_dit; dit++)
1320  MOFEM_LOG("SYNC", Sev::inform) << *dit;
1321 
1324 }

◆ list_fields()

MoFEMErrorCode MoFEM::Core::list_fields ( ) const
protectedvirtual

list entities in the field

Implements MoFEM::CoreInterface.

Definition at line 1326 of file FieldCore.cpp.

1326  {
1328  MOFEM_LOG("SYNC", Sev::inform) << "List Fields:";
1329  for (auto &miit : fIelds.get<BitFieldId_mi_tag>())
1330  MOFEM_LOG("SYNC", Sev::inform) << *miit;
1331 
1334 }

◆ list_finite_elements()

MoFEMErrorCode MoFEM::Core::list_finite_elements ( ) const
protectedvirtual

list finite elements in database

Implements MoFEM::CoreInterface.

Definition at line 320 of file FECore.cpp.

320  {
322  for (auto &fe : finiteElements.get<FiniteElement_name_mi_tag>())
323  MOFEM_LOG("SYNC", Sev::inform) << fe;
324 
327 }

◆ list_problem()

MoFEMErrorCode MoFEM::Core::list_problem ( ) const
protectedvirtual

list problems

Implements MoFEM::CoreInterface.

Definition at line 129 of file ProblemsCore.cpp.

129  {
132  const ProblemById &set_id = pRoblems.get<BitProblemId_mi_tag>();
133  ProblemById::iterator miit = set_id.begin();
134  for (; miit != set_id.end(); miit++) {
135  std::ostringstream ss;
136  ss << *miit << std::endl;
137  PetscPrintf(mofemComm, ss.str().c_str());
138  }
140 }

◆ loop_dofs() [1/4]

MoFEMErrorCode MoFEM::Core::loop_dofs ( const Problem problem_ptr,
const std::string &  field_name,
RowColData  rc,
DofMethod method,
int  lower_rank,
int  upper_rank,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Make a loop over dofs.

Implements MoFEM::CoreInterface.

Definition at line 531 of file ProblemsCore.cpp.

534  {
536  SET_BASIC_METHOD(method, &*problem_ptr);
538  NumeredDofsByUId;
539  NumeredDofsByUId *dofs;
540  switch (rc) {
541  case ROW:
542  dofs = &problem_ptr->numeredRowDofsPtr->get<Unique_mi_tag>();
543  break;
544  case COL:
545  dofs = &problem_ptr->numeredColDofsPtr->get<Unique_mi_tag>();
546  break;
547  default:
548  SETERRQ(mofemComm, MOFEM_DATA_INCONSISTENCY, "Not implemented");
549  }
550 
551  auto field_it = fIelds.get<FieldName_mi_tag>().find(field_name);
552  if (field_it != fIelds.get<FieldName_mi_tag>().end()) {
553  method.fieldPtr = *field_it;
554  } else {
555  SETERRQ(mofemComm, MOFEM_NOT_FOUND,
556  ("Field not found " + field_name).c_str());
557  }
558 
559  auto miit = dofs->lower_bound(
560  FieldEntity::getLoBitNumberUId((*field_it)->getBitNumber()));
561  auto hi_miit = dofs->upper_bound(
562  FieldEntity::getHiBitNumberUId((*field_it)->getBitNumber()));
563 
564  method.loopSize = std::distance(miit, hi_miit);
565  method.loHiFERank = std::make_pair(lower_rank, upper_rank);
566 
567  CHKERR method.preProcess();
568 
569  int nn = 0;
570  for (; miit != hi_miit; miit++, nn++) {
571  if ((*miit)->getPart() >= lower_rank && (*miit)->getPart() <= upper_rank) {
572  method.nInTheLoop = nn; // Index of element in the loop
573  method.dofPtr = miit->get()->getDofEntityPtr();
574  method.dofNumeredPtr = *miit;
575  CHKERR method();
576  }
577  }
578 
579  CHKERR method.postProcess();
581 }

◆ loop_dofs() [2/4]

MoFEMErrorCode MoFEM::Core::loop_dofs ( const std::string &  field_name,
DofMethod method,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Make a loop over dofs.

Implements MoFEM::CoreInterface.

Definition at line 617 of file ProblemsCore.cpp.

618  {
620  if (verb == DEFAULT_VERBOSITY)
621  verb = verbose;
622  SET_BASIC_METHOD(method, nullptr);
623 
624  auto field_it = fIelds.get<FieldName_mi_tag>().find(field_name);
625  if (field_it != fIelds.get<FieldName_mi_tag>().end()) {
626  method.fieldPtr = *field_it;
627  } else {
628  SETERRQ(mofemComm, MOFEM_NOT_FOUND,
629  ("Field not found " + field_name).c_str());
630  }
631 
632  auto miit = dofsField.get<Unique_mi_tag>().lower_bound(
633  FieldEntity::getLoBitNumberUId((*field_it)->getBitNumber()));
634  auto hi_miit = dofsField.get<Unique_mi_tag>().upper_bound(
635  FieldEntity::getHiBitNumberUId((*field_it)->getBitNumber()));
636 
637  method.loopSize = std::distance(miit, hi_miit);
638  method.loHiFERank = std::make_pair(0, get_comm_size());
639 
640  CHKERR method.preProcess();
641  for (int nn = 0; miit != hi_miit; miit++, nn++) {
642  method.nInTheLoop = nn;
643  method.dofPtr = *miit;
644  CHKERR method();
645  }
646  CHKERR method.postProcess();
648 }

◆ loop_dofs() [3/4]

MoFEMErrorCode MoFEM::Core::loop_dofs ( const std::string &  problem_name,
const std::string &  field_name,
RowColData  rc,
DofMethod method,
int  lower_rank,
int  upper_rank,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Make a loop over dofs.

Implements MoFEM::CoreInterface.

Definition at line 583 of file ProblemsCore.cpp.

591  {
593  if (verb == DEFAULT_VERBOSITY)
594  verb = verbose;
596  // find p_miit
597  ProblemsByName &pRoblems_set = pRoblems.get<Problem_mi_tag>();
598  ProblemsByName::iterator p_miit = pRoblems_set.find(problem_name);
599  if (p_miit == pRoblems_set.end())
600  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "problem not in database %s",
601  problem_name.c_str());
602  CHKERR loop_dofs(&*p_miit, field_name, rc, method, lower_rank, upper_rank,
603  verb);
605 }

◆ loop_dofs() [4/4]

MoFEMErrorCode MoFEM::Core::loop_dofs ( const std::string &  problem_name,
const std::string &  field_name,
RowColData  rc,
DofMethod method,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Make a loop over dofs.

Implements MoFEM::CoreInterface.

Definition at line 607 of file ProblemsCore.cpp.

609  {
611  if (verb == DEFAULT_VERBOSITY)
612  verb = verbose;
613  CHKERR loop_dofs(problem_name, field_name, rc, method, 0, sIze, verb);
615 }

◆ loop_entities() [1/4]

MoFEMErrorCode MoFEM::Core::loop_entities ( const Problem problem_ptr,
const std::string  field_name,
RowColData  rc,
EntityMethod method,
int  lower_rank,
int  upper_rank,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Loop over field entities in the problem.

Parameters
problem_ptr
field_name
rc
method
lower_rank
upper_rank
verb
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 650 of file ProblemsCore.cpp.

653  {
655  if (verb == DEFAULT_VERBOSITY)
656  verb = verbose;
657  decltype(problem_ptr->numeredRowDofsPtr) dofs;
658  switch (rc) {
659  case ROW:
660  dofs = problem_ptr->numeredRowDofsPtr;
661  break;
662  case COL:
663  dofs = problem_ptr->numeredColDofsPtr;
664  break;
665  default:
667  "It works only with rows or columns");
668  }
669 
670  auto field_it = fIelds.get<FieldName_mi_tag>().find(field_name);
671  if (field_it != fIelds.get<FieldName_mi_tag>().end()) {
672  method.fieldPtr = *field_it;
673  } else {
674  SETERRQ(mofemComm, MOFEM_NOT_FOUND,
675  ("Field not found " + field_name).c_str());
676  }
677 
678  auto miit = dofs->lower_bound(
679  FieldEntity::getLoBitNumberUId((*field_it)->getBitNumber()));
680  auto hi_miit = dofs->upper_bound(
681  FieldEntity::getHiBitNumberUId((*field_it)->getBitNumber()));
682 
683  using FieldEntity_view_multiIndex = multi_index_container<
684 
685  boost::shared_ptr<FieldEntity>,
686  indexed_by<
687 
688  ordered_unique<
689 
690  tag<Ent_mi_tag>,
693 
694  >>;
695 
696  FieldEntity_view_multiIndex ents_view;
697  auto hint = ents_view.begin();
698  for (; miit != hi_miit; ++miit)
699  if ((*miit)->getPart() >= lower_rank && (*miit)->getPart() <= upper_rank)
700  ents_view.emplace_hint(hint, (*miit)->getFieldEntityPtr());
701 
702  SET_BASIC_METHOD(method, problem_ptr);
703 
704  method.loopSize = ents_view.size();
705  method.loHiFERank = std::make_pair(lower_rank, upper_rank);
706 
707  CHKERR method.preProcess();
708  method.nInTheLoop = 0;
709  for (auto &field_ent : ents_view) {
710  method.entPtr = field_ent;
711  CHKERR method();
712  ++method.nInTheLoop;
713  }
714  CHKERR method.postProcess();
716 }

◆ loop_entities() [2/4]

MoFEMErrorCode MoFEM::Core::loop_entities ( const std::string  field_name,
EntityMethod method,
Range const *const  ents = nullptr,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Loop over field entities.

Parameters
field_namefield entities
methoduser method
entsif given loop only on subset of entities in the field
verb
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 742 of file ProblemsCore.cpp.

744  {
746  if (verb == DEFAULT_VERBOSITY)
747  verb = verbose;
748  SET_BASIC_METHOD(method, nullptr);
749 
750  auto field_it = fIelds.get<FieldName_mi_tag>().find(field_name);
751  if (field_it != fIelds.get<FieldName_mi_tag>().end()) {
752  method.fieldPtr = *field_it;
753  } else {
754  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "Field not found %s",
755  field_name.c_str());
756  }
757 
758  auto lo_eit = entsFields.get<Unique_mi_tag>().lower_bound(
759  FieldEntity::getLoBitNumberUId((*field_it)->getBitNumber()));
760  auto hi_eit = entsFields.get<Unique_mi_tag>().upper_bound(
761  FieldEntity::getHiBitNumberUId((*field_it)->getBitNumber()));
762 
763  typedef multi_index_container<
764  boost::shared_ptr<FieldEntity>,
765  indexed_by<ordered_unique<
766  tag<Ent_mi_tag>, const_mem_fun<FieldEntity::interface_RefEntity,
768  FieldEntity_view_multiIndex;
769 
770  FieldEntity_view_multiIndex ents_view;
771  ents_view.insert(lo_eit, hi_eit);
772 
773  method.loopSize = ents_view.size();
774  method.loHiFERank = std::make_pair(0, get_comm_size());
775 
776  CHKERR method.preProcess();
777  method.nInTheLoop = 0;
778 
779  if (ents)
780  for (auto p = ents->const_pair_begin(); p != ents->const_pair_end(); ++p)
781  for (auto feit = ents_view.lower_bound(p->first);
782  feit != ents_view.upper_bound(p->second); ++feit) {
783  method.entPtr = *feit;
784  CHKERR method();
785  ++method.nInTheLoop;
786  }
787  else
788  for (auto &field_ent : ents_view) {
789  method.entPtr = field_ent;
790  CHKERR method();
791  ++method.nInTheLoop;
792  }
793 
794  CHKERR method.postProcess();
796 }

◆ loop_entities() [3/4]

MoFEMErrorCode MoFEM::Core::loop_entities ( const std::string  problem_name,
const std::string  field_name,
RowColData  rc,
EntityMethod method,
int  lower_rank,
int  upper_rank,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Loop over field entities in the problem.

Parameters
problem_name
field_name
rc
method
lower_rank
upper_rank
verb
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 718 of file ProblemsCore.cpp.

721  {
723  if (verb == DEFAULT_VERBOSITY)
724  verb = verbose;
725  // find p_miit
726  auto &prb = pRoblems.get<Problem_mi_tag>();
727  auto p_miit = prb.find(problem_name);
728  if (p_miit == prb.end())
729  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "problem not in database %s",
730  problem_name.c_str());
731  CHKERR loop_entities(&*p_miit, field_name, rc, method, lower_rank, upper_rank,
732  verb);
734 }

◆ loop_entities() [4/4]

MoFEMErrorCode MoFEM::Core::loop_entities ( const std::string  problem_name,
const std::string  field_name,
RowColData  rc,
EntityMethod method,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Loop over field entities in the problem.

Parameters
problem_name
field_name
rc
method
verb
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 736 of file ProblemsCore.cpp.

738  {
739  return loop_entities(problem_name, field_name, rc, method, rAnk, rAnk, verb);
740 }

◆ loop_finite_elements() [1/3]

MoFEMErrorCode MoFEM::Core::loop_finite_elements ( const Problem problem_ptr,
const std::string &  fe_name,
FEMethod method,
int  lower_rank,
int  upper_rank,
boost::shared_ptr< NumeredEntFiniteElement_multiIndex fe_ptr = nullptr,
MoFEMTypes  bh = MF_EXIST,
CacheTupleWeakPtr  cache_ptr = CacheTupleSharedPtr(),
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Make a loop over finite elements on partitions from upper to lower rank.

This function is like swiss knife, is can be used to post-processing or matrix and vectors assembly. It makes loop over given finite element for given problem. The particular methods executed on each element are given by class derived form Interface::FEMethod. At beginning of each loop user defined function (method) preProcess() is called, for each element operator() is executed, at the end loop finalizes with user defined function (method) postProcess().

Note
If fe_ptr is given it is expected that multi-index is supbes of problem multi-index. If this is not the case behavior of the code is undetermined.

For more details please look to examples.

Interface::FEMethod

Parameters
problem_ptrpointer to problem consisting set of elements
fe_namename of element in problem
methodclass derived form Interface::FEMethod
lower_ranklower rank of process owned by finite element
upper_ranklower rank of process owned by finite element
fe_ptrpointer to finite elements multi-index
bhif bH = MF_EXIST, throws error if fe_name does not exist
cache_datacache data vector
cache_rowcache row vector
cache_colcache row vector
verbverbosity level
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 427 of file ProblemsCore.cpp.

431  {
433  if (verb == DEFAULT_VERBOSITY)
434  verb = verbose;
435 
436  CacheTupleSharedPtr tmp_cache_ptr;
437  if (!cache_ptr.use_count()) {
438  tmp_cache_ptr = boost::make_shared<CacheTuple>();
439  CHKERR cache_problem_entities(problem_ptr->getName(), tmp_cache_ptr);
440  method.cacheWeakPtr = tmp_cache_ptr;
441  } else {
442  method.cacheWeakPtr = cache_ptr;
443  }
444 
445  if (!fe_ptr)
446  fe_ptr = problem_ptr->numeredFiniteElementsPtr;
447 
448  auto miit = fe_ptr->get<Composite_Name_And_Part_mi_tag>().lower_bound(
449  boost::make_tuple(fe_name, lower_rank));
450  auto hi_miit = fe_ptr->get<Composite_Name_And_Part_mi_tag>().upper_bound(
451  boost::make_tuple(fe_name, upper_rank));
452 
453  if (miit == hi_miit && (bh & MF_EXIST)) {
454  if (!check_finite_element(fe_name)) {
455  SETERRQ1(mofemComm, MOFEM_NOT_FOUND, "finite element < %s > not found",
456  fe_name.c_str());
457  }
458  }
459 
460  method.feName = fe_name;
461  method.loopSize =
462  std::distance(miit, hi_miit); // Set numbers of elements in the loop
463  method.loHiFERank = std::make_pair(lower_rank, upper_rank);
464 
465  SET_BASIC_METHOD(method, &*problem_ptr)
466 
467  PetscLogEventBegin(MOFEM_EVENT_preProcess, 0, 0, 0, 0);
468  CHKERR method.preProcess();
469  PetscLogEventEnd(MOFEM_EVENT_preProcess, 0, 0, 0, 0);
470 
471  PetscLogEventBegin(MOFEM_EVENT_operator, 0, 0, 0, 0);
472  for (int nn = 0; miit != hi_miit; miit++, nn++) {
473 
474  method.nInTheLoop = nn; // Index of element in the loop
475  method.numeredEntFiniteElementPtr = *miit;
476 
477  if (method.exeTestHook) {
478  if (method.exeTestHook(&method)) {
479  CHKERR method();
480  }
481  } else {
482  CHKERR method();
483  }
484 
485  }
486  PetscLogEventEnd(MOFEM_EVENT_operator, 0, 0, 0, 0);
487 
488  PetscLogEventBegin(MOFEM_EVENT_postProcess, 0, 0, 0, 0);
489  CHKERR method.postProcess();
490  PetscLogEventEnd(MOFEM_EVENT_postProcess, 0, 0, 0, 0);
491 
493 }

◆ loop_finite_elements() [2/3]

MoFEMErrorCode MoFEM::Core::loop_finite_elements ( const std::string  problem_name,
const std::string &  fe_name,
FEMethod method,
boost::shared_ptr< NumeredEntFiniteElement_multiIndex fe_ptr = nullptr,
MoFEMTypes  bh = MF_EXIST,
CacheTupleWeakPtr  cache_ptr = CacheTupleSharedPtr(),
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Make a loop over finite elements.

This function is like swiss knife, is can be used to post-processing or matrix and vectors assembly. It makes loop over given finite element for given problem. The particular methods executed on each element are given by class derived form Interface::FEMethod. At beginning of each loop user defined function (method) preProcess() is called, for each element operator() is executed, at the end loop finalizes with user defined function (method) postProcess().

Methods are executed only for local elements at given processor.

For more details pleas look to examples.

Note
If fe_ptr is given it is expected that multi-index is supbes of problem multi-index. If this is not the case behavior of the code is undetermined.
Parameters
problem_nameproblem consisting set of elements
fe_namename of element in problem
methodclass derived form Interface::FEMethod
fe_ptrpointer to finite elements multi-index
bhif bH = MF_EXIST, throws error if fe_name does not exist
cache_tuple_ptrcache
verbverbosity level
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 495 of file ProblemsCore.cpp.

499  {
501  if (verb == DEFAULT_VERBOSITY)
502  verb = verbose;
503 
504  CHKERR loop_finite_elements(problem_name, fe_name, method, rAnk, rAnk, fe_ptr,
505  bh, cache_ptr, verb);
506 
508 }

◆ loop_finite_elements() [3/3]

MoFEMErrorCode MoFEM::Core::loop_finite_elements ( const std::string  problem_name,
const std::string &  fe_name,
FEMethod method,
int  lower_rank,
int  upper_rank,
boost::shared_ptr< NumeredEntFiniteElement_multiIndex fe_ptr = nullptr,
MoFEMTypes  bh = MF_EXIST,
CacheTupleWeakPtr  cache_ptr = CacheTupleSharedPtr(),
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Make a loop over finite elements on partitions from upper to lower rank.

This function is like swiss knife, is can be used to post-processing or matrix and vectors assembly. It makes loop over given finite element for given problem. The particular methods executed on each element are given by class derived form Interface::FEMethod. At beginning of each loop user defined function (method) preProcess() is called, for each element operator() is executed, at the end loop finalizes with user defined function (method) postProcess().

Note
If fe_ptr is given it is expected that multi-index is supbes of problem multi-index. If this is not the case behavior of the code is undetermined.

For more details please look to examples.

Parameters
problem_namepointer to problem consisting set of elements
fe_namename of element in problem
methodclass derived form Interface::FEMethod
lower_ranklower rank of process owned by finite element
upper_ranklower rank of process owned by finite element
fe_ptrpointer to finite elements multi-index
bhif bH = MF_EXIST, throws error if fe_name does not exist
cache_datacache data vector
cache_rowcache row vector
cache_colcache row vector
verbverbosity level
Returns
error code

Implements MoFEM::CoreInterface.

Definition at line 510 of file ProblemsCore.cpp.

514  {
516  if (verb == DEFAULT_VERBOSITY)
517  verb = verbose;
518 
519  auto &prb_by_name = pRoblems.get<Problem_mi_tag>();
520  auto p_miit = prb_by_name.find(problem_name);
521  if (p_miit == prb_by_name.end())
522  SETERRQ1(mofemComm, MOFEM_INVALID_DATA, "Problem <%s> is not in database",
523  problem_name.c_str());
524 
525  CHKERR loop_finite_elements(&*p_miit, fe_name, method, lower_rank, upper_rank,
526  fe_ptr, bh, cache_ptr, verb);
527 
529 }

◆ make_shared_ref_entity()

boost::shared_ptr< RefEntityTmp< 0 > > MoFEM::Core::make_shared_ref_entity ( const EntityHandle  ent)
virtual

Get RefEntity.

Parameters
ent
Returns
boost::shared_ptr<RefEntityTmp<0>>

Implements MoFEM::CoreInterface.

Reimplemented in MoFEM::CoreTmp<-1 >.

Definition at line 962 of file Core.cpp.

962  {
963  return this->makeSharedRefEntity(*this, ent);
964 }

◆ makeSharedRefEntity()

boost::shared_ptr< RefEntityTmp< 0 > > MoFEM::Core::makeSharedRefEntity ( MoFEM::Interface m_field,
const EntityHandle  ent 
)
static

Definition at line 928 of file Core.cpp.

928  {
929 
930  boost::shared_ptr<RefEntityTmp<0>> ref_ent_ptr;
931 
932  switch (m_field.getValue()) {
933  case -1:
934  ref_ent_ptr = boost::shared_ptr<RefEntityTmp<0>>(
935 
936  new RefEntityTmp<-1>(m_field.get_basic_entity_data_ptr(), ent)
937 
938  );
939  break;
940  case 0:
941  ref_ent_ptr = boost::shared_ptr<RefEntityTmp<0>>(
942 
943  new RefEntityTmp<0>(m_field.get_basic_entity_data_ptr(), ent)
944 
945  );
946  break;
947  case 1:
948  ref_ent_ptr = boost::shared_ptr<RefEntityTmp<0>>(
949 
950  new RefEntityTmp<1>(m_field.get_basic_entity_data_ptr(), ent)
951 
952  );
953  break;
954  default:
955  THROW_MESSAGE("Core index can vary from -1 to MAX_CORE_TMP");
956  }
957 
958  return ref_ent_ptr;
959 }

◆ modify_finite_element_add_field_col()

MoFEMErrorCode MoFEM::Core::modify_finite_element_add_field_col ( const std::string &  fe_name,
const std::string  name_row 
)
protectedvirtual

set field col which finite element use

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.
Parameters
namefinite element name
namefield name

Implements MoFEM::CoreInterface.

Definition at line 182 of file FECore.cpp.

183  {
185  *buildMoFEM &= 1 << 0;
186  auto &finite_element_name_set =
187  finiteElements.get<FiniteElement_name_mi_tag>();
188  auto it_fe = finite_element_name_set.find(fe_name);
189  if (it_fe == finite_element_name_set.end())
191  "this FiniteElement is there");
192  bool success = finite_element_name_set.modify(
193  it_fe, FiniteElement_col_change_bit_add(get_field_id(name_col)));
194  if (!success)
196  "modification unsuccessful");
198 }

◆ modify_finite_element_add_field_data()

MoFEMErrorCode MoFEM::Core::modify_finite_element_add_field_data ( const std::string &  fe_name,
const std::string  name_filed 
)
protectedvirtual

set finite element field data

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.
Parameters
namefinite element name
namefield name

This function will set memory in the form of a vector

Implements MoFEM::CoreInterface.

Definition at line 138 of file FECore.cpp.

139  {
141  *buildMoFEM &= 1 << 0;
143  FiniteElements_by_name;
144  FiniteElements_by_name &finite_element_name_set =
145  finiteElements.get<FiniteElement_name_mi_tag>();
146  FiniteElements_by_name::iterator it_fe =
147  finite_element_name_set.find(fe_name);
148  if (it_fe == finite_element_name_set.end())
149  SETERRQ(mofemComm, MOFEM_NOT_FOUND,
150  "This finite element is not defined (advise: check spelling)");
151  bool success = finite_element_name_set.modify(
152  it_fe, FiniteElement_change_bit_add(get_field_id(name_data)));
153  if (!success)
155  "modification unsuccessful");
157 }

◆ modify_finite_element_add_field_row()

MoFEMErrorCode MoFEM::Core::modify_finite_element_add_field_row ( const std::string &  fe_name,
const std::string  name_row 
)
protectedvirtual

set field row which finite element use

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.
Parameters
namefinite element name
namefield name

Implements MoFEM::CoreInterface.

Definition at line 160 of file FECore.cpp.

161  {
163  *buildMoFEM &= 1 << 0;
165  FiniteElements_by_name;
166  FiniteElements_by_name &finite_element_name_set =
167  finiteElements.get<FiniteElement_name_mi_tag>();
168  FiniteElements_by_name::iterator it_fe =
169  finite_element_name_set.find(fe_name);
170  if (it_fe == finite_element_name_set.end())
171  SETERRQ1(mofemComm, MOFEM_NOT_FOUND, "this < %s > is not there",
172  fe_name.c_str());
173  bool success = finite_element_name_set.modify(
174  it_fe, FiniteElement_row_change_bit_add(get_field_id(name_row)));
175  if (!success)
177  "modification unsuccessful");
179 }

◆ modify_finite_element_adjacency_table()

MoFEMErrorCode MoFEM::Core::modify_finite_element_adjacency_table ( const std::string &  fe_name,
const EntityType  type,
ElementAdjacencyFunct  function 
)
protectedvirtual

modify finite element table, only for advanced user

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.

Using that functions means that you like to do something not usual.

Implements MoFEM::CoreInterface.

Definition at line 117 of file FECore.cpp.

119  {
121  *buildMoFEM &= 1 << 0;
123  FiniteElements_by_name;
124  FiniteElements_by_name &finite_element_name_set =
125  finiteElements.get<FiniteElement_name_mi_tag>();
126  FiniteElements_by_name::iterator it_fe =
127  finite_element_name_set.find(fe_name);
128  if (it_fe == finite_element_name_set.end())
129  SETERRQ(mofemComm, MOFEM_NOT_FOUND,
130  "This finite element is not defined (advise: check spelling)");
131  boost::shared_ptr<FiniteElement> fe;
132  fe = *it_fe;
133  fe->elementAdjacencyTable[type] = function;
135 }

◆ modify_finite_element_off_field_col()

MoFEMErrorCode MoFEM::Core::modify_finite_element_off_field_col ( const std::string &  fe_name,
const std::string  name_row 
)
protectedvirtual

unset field col which finite element use

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.
Parameters
namefinite element name
namefield name

Implements MoFEM::CoreInterface.

Definition at line 238 of file FECore.cpp.

239  {
241  *buildMoFEM &= 1 << 0;
242  auto &finite_element_name_set =
243  finiteElements.get<FiniteElement_name_mi_tag>();
244  auto it_fe = finite_element_name_set.find(fe_name);
245  if (it_fe == finite_element_name_set.end())
246  SETERRQ(mofemComm, MOFEM_NOT_FOUND, "this FiniteElement is there");
247  bool success = finite_element_name_set.modify(
248  it_fe, FiniteElement_col_change_bit_off(get_field_id(name_col)));
249  if (!success)
251  "modification unsuccessful");
253 }

◆ modify_finite_element_off_field_data()

MoFEMErrorCode MoFEM::Core::modify_finite_element_off_field_data ( const std::string &  fe_name,
const std::string  name_filed 
)
protectedvirtual

unset finite element field data

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.
Parameters
namefinite element name
namefield name

This function will set memory in the form of a vector

Implements MoFEM::CoreInterface.

Definition at line 201 of file FECore.cpp.

202  {
204  *buildMoFEM &= 1 << 0;
205  auto &finite_element_name_set =
206  finiteElements.get<FiniteElement_name_mi_tag>();
207  auto it_fe = finite_element_name_set.find(fe_name);
208  if (it_fe == finite_element_name_set.end())
209  SETERRQ(mofemComm, MOFEM_NOT_FOUND, "this FiniteElement is there");
210  bool success = finite_element_name_set.modify(
211  it_fe, FiniteElement_change_bit_off(get_field_id(name_data)));
212  if (!success)
214  "modification unsuccessful");
216 }

◆ modify_finite_element_off_field_row()

MoFEMErrorCode MoFEM::Core::modify_finite_element_off_field_row ( const std::string &  fe_name,
const std::string  name_row 
)
protectedvirtual

unset field row which finite element use

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.
Parameters
namefinite element name
namefield name

Implements MoFEM::CoreInterface.

Definition at line 219 of file FECore.cpp.

220  {
222  *buildMoFEM &= 1 << 0;
223  auto &finite_element_name_set =
224  finiteElements.get<FiniteElement_name_mi_tag>();
225  auto it_fe = finite_element_name_set.find(fe_name);
226  if (it_fe == finite_element_name_set.end())
227  SETERRQ1(mofemComm, MOFEM_NOT_FOUND, "this < %s > is not there",
228  fe_name.c_str());
229  bool success = finite_element_name_set.modify(
230  it_fe, FiniteElement_row_change_bit_off(get_field_id(name_row)));
231  if (!success)
233  "modification unsuccessful");
235 }

◆ modify_problem_add_finite_element()

MoFEMErrorCode MoFEM::Core::modify_problem_add_finite_element ( const std::string  name_problem,
const std::string &  fe_name 
)
protectedvirtual

add finite element to problem, this add entities assigned to finite element to a particular problem

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.
Parameters
nameProblem name
nameFinite Element name

Implements MoFEM::CoreInterface.

Definition at line 143 of file ProblemsCore.cpp.

144  {
147  ProblemsByName &set = pRoblems.get<Problem_mi_tag>();
148  ProblemsByName::iterator miit = set.find(name_problem);
149  if (miit == set.end()) {
150  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "this problem <%s> is not there",
151  name_problem.c_str());
152  }
153  BitFEId f_id = getBitFEId(fe_name);
154  bool success = set.modify(miit, ProblemFiniteElementChangeBitAdd(f_id));
155  if (!success)
156  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
157  "modification unsuccessful");
159 }

◆ modify_problem_mask_ref_level_add_bit()

MoFEMErrorCode MoFEM::Core::modify_problem_mask_ref_level_add_bit ( const std::string &  name_problem,
const BitRefLevel bit 
)
protectedvirtual

set dof mask ref level for problem

Implements MoFEM::CoreInterface.

Definition at line 218 of file ProblemsCore.cpp.

219  {
222  ProblemsByName &set = pRoblems.get<Problem_mi_tag>();
223  ProblemsByName::iterator miit = set.find(name_problem);
224  if (miit == set.end()) {
225  std::ostringstream ss;
226  ss << name_problem;
227  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "this problem <%s> is there",
228  ss.str().c_str());
229  }
230  bool success = set.modify(miit, ProblemChangeRefLevelBitDofMaskAdd(bit));
231  if (!success)
232  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
233  "modification unsuccessful");
235 }

◆ modify_problem_mask_ref_level_set_bit()

MoFEMErrorCode MoFEM::Core::modify_problem_mask_ref_level_set_bit ( const std::string &  name_problem,
const BitRefLevel bit 
)
protectedvirtual

set dof mask ref level for problem

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.

Implements MoFEM::CoreInterface.

Definition at line 238 of file ProblemsCore.cpp.

239  {
241  ProblemsByName;
242  ProblemsByName &set = pRoblems.get<Problem_mi_tag>();
243  ProblemsByName::iterator miit = set.find(name_problem);
244  if (miit == set.end()) {
245  std::ostringstream ss;
246  ss << name_problem;
247  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "this problem <%s> is there",
248  ss.str().c_str());
249  }
250  bool success = set.modify(miit, ProblemChangeRefLevelBitDofMaskSet(bit));
251  if (!success)
252  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
253  "modification unsuccessful");
255 }

◆ modify_problem_ref_level_add_bit()

MoFEMErrorCode MoFEM::Core::modify_problem_ref_level_add_bit ( const std::string &  name_problem,
const BitRefLevel bit 
)
protectedvirtual

add ref level to problem

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.

if same finite element is solved using different level of refinements, than the level of refinement has to be specificied to problem in query

Parameters
nameProblem name
BitRefLevelbitLevel Example:
mField.modify_problem_add_finite_element("BEAM_BENDING_ON_MESH_REF1","ELASTIC");
mField.modify_problem_add_finite_element("BEAM_BENDING_ON_MESH_REF2","ELASTIC");
mField.modify_problem_ref_level_add_bit("BEAM_BENDING_ON_MESH_REF1",bit_level1);
mField.modify_problem_ref_level_add_bit("BEAM_BENDING_ON_MESH_REF2",bit_level2);
Two Problems exist and solved independently, both are elastic, but solved using different mesh refinement

Implements MoFEM::CoreInterface.

Definition at line 181 of file ProblemsCore.cpp.

182  {
185  ProblemsByName &set = pRoblems.get<Problem_mi_tag>();
186  ProblemsByName::iterator miit = set.find(name_problem);
187  std::ostringstream ss;
188  ss << name_problem;
189  if (miit == set.end())
190  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "this problem <%s> is there",
191  ss.str().c_str());
192  bool success = set.modify(miit, ProblemChangeRefLevelBitAdd(bit));
193  if (!success)
194  SETERRQ(PETSC_COMM_SELF, 1, "modification unsuccessful");
196 }

◆ modify_problem_ref_level_set_bit()

MoFEMErrorCode MoFEM::Core::modify_problem_ref_level_set_bit ( const std::string &  name_problem,
const BitRefLevel bit 
)
protectedvirtual

set ref level for problem

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.

if same finite element is solved using different level of refinements, than the level of refinement has to be specificied to problem in query

Parameters
nameProblem name
BitRefLevelbitLevel Example:
mField.modify_problem_add_finite_element("BEAM_BENDING_ON_MESH_REF1","ELASTIC");
mField.modify_problem_add_finite_element("BEAM_BENDING_ON_MESH_REF2","ELASTIC");
mField.modify_problem_ref_level_set_bit("BEAM_BENDING_ON_MESH_REF1",bit_level1);
mField.modify_problem_ref_level_set_bit("BEAM_BENDING_ON_MESH_REF2",bit_level2);
Two Problems exist and solved independently, both are elastic, but solved using different mesh refinement

Implements MoFEM::CoreInterface.

Definition at line 199 of file ProblemsCore.cpp.

200  {
203  ProblemsByName &set = pRoblems.get<Problem_mi_tag>();
204  ProblemsByName::iterator miit = set.find(name_problem);
205  std::ostringstream ss;
206  ss << name_problem;
207  if (miit == set.end())
208  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "this problem <%s> is there",
209  ss.str().c_str());
210  bool success = set.modify(miit, ProblemChangeRefLevelBitSet(bit));
211  if (!success)
212  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
213  "modification unsuccessful");
215 }

◆ modify_problem_unset_finite_element()

MoFEMErrorCode MoFEM::Core::modify_problem_unset_finite_element ( const std::string  name_problem,
const std::string &  fe_name 
)
protectedvirtual

unset finite element from problem, this remove entities assigned to finite element to a particular problem

Note: If problem is build, it need to be cleaned to make this effective

Note
add_file is a collective, should be executed on all processors. Otherwise could lead to deadlock.
Parameters
nameProblem name
nameFinite Element name

Implements MoFEM::CoreInterface.

Definition at line 162 of file ProblemsCore.cpp.

163  {
166  ProblemsByName &set = pRoblems.get<Problem_mi_tag>();
167  ProblemsByName::iterator miit = set.find(name_problem);
168  if (miit == set.end()) {
169  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "this problem <%s> is not there",
170  name_problem.c_str());
171  }
172  BitFEId f_id = getBitFEId(fe_name);
173  bool success = set.modify(miit, ProblemFiniteElementChangeBitUnSet(f_id));
174  if (!success)
175  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
176  "modification unsuccessful");
178 }

◆ problem_basic_method_postProcess() [1/2]

MoFEMErrorCode MoFEM::Core::problem_basic_method_postProcess ( const Problem problem_ptr,
BasicMethod method,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Set data for BasicMethod.

This function set data about problem, adjacencies and other multi-indices in database. This function can be used a special case when user need to do some pre- and post-processing before matrix or vector is initiated, or to assemble matrix for group of FEMethods. Is used by classes SnesCtx and TsCtx. Look for more details there.

FIXME: Here we need example

Parameters
pointerto problem data structure
methoduser method derived from BasicMethod

Implements MoFEM::CoreInterface.

Definition at line 395 of file ProblemsCore.cpp.

396  {
398  SET_BASIC_METHOD(method, problem_ptr)
399 
400  PetscLogEventBegin(MOFEM_EVENT_postProcess, 0, 0, 0, 0);
401  CHKERR method.postProcess();
402  PetscLogEventEnd(MOFEM_EVENT_postProcess, 0, 0, 0, 0);
403 
405 }

◆ problem_basic_method_postProcess() [2/2]

MoFEMErrorCode MoFEM::Core::problem_basic_method_postProcess ( const std::string &  problem_name,
BasicMethod method,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Set data for BasicMethod.

This function set data about problem, adjacencies and other multi-indices in database. This function can be used a special case when user need to do some pre- and post-processing before matrix or vector is initiated, or to assemble matrix for group of FEMethods. Is used by classes SnesCtx and TsCtx. Look for more details there.

FIXME: Here we need example

Parameters
problem_namename of the problem
methoduser method derived from BasicMethod

Implements MoFEM::CoreInterface.

Definition at line 408 of file ProblemsCore.cpp.

409  {
411  if (verb == -1)
412  verb = verbose;
414 
415  // find p_miit
416  ProblemsByName &pRoblems_set = pRoblems.get<Problem_mi_tag>();
417  ProblemsByName::iterator p_miit = pRoblems_set.find(problem_name);
418  if (p_miit == pRoblems_set.end())
419  SETERRQ1(mofemComm, 1, "problem is not in database %s",
420  problem_name.c_str());
421 
422  CHKERR problem_basic_method_postProcess(&*p_miit, method, verb);
423 
425 }

◆ problem_basic_method_preProcess() [1/2]

MoFEMErrorCode MoFEM::Core::problem_basic_method_preProcess ( const Problem problem_ptr,
BasicMethod method,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Set data for BasicMethod.

This function set data about problem, adjacencies and other multi-indices in database. This function can be used a special case when user need to do some pre- and post-processing before matrix or vector is initiated, or to assemble matrix for group of FEMethods. Is used by classes SnesCtx and TsCtx. Look for more details there.

FIXME: Here we need example

Parameters
pointerto problem data structure
methoduser method derived from BasicMethod

Implements MoFEM::CoreInterface.

Definition at line 363 of file ProblemsCore.cpp.

365  {
367  if (verb == -1)
368  verb = verbose;
369  // finite element
370  SET_BASIC_METHOD(method, problem_ptr)
371  PetscLogEventBegin(MOFEM_EVENT_preProcess, 0, 0, 0, 0);
372  CHKERR method.preProcess();
373  PetscLogEventEnd(MOFEM_EVENT_preProcess, 0, 0, 0, 0);
375 }

◆ problem_basic_method_preProcess() [2/2]

MoFEMErrorCode MoFEM::Core::problem_basic_method_preProcess ( const std::string &  problem_name,
BasicMethod method,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Set data for BasicMethod.

This function set data about problem, adjacencies and other multi-indices in database. This function can be used a special case when user need to do some pre- and post-processing before matrix or vector is initiated, or to assemble matrix for group of FEMethods. Is used by classes SnesCtx and TsCtx. Look for more details there.

FIXME: Here we need example

Parameters
problem_namename of the problem
methoduser method derived from BasicMethod

Implements MoFEM::CoreInterface.

Definition at line 378 of file ProblemsCore.cpp.

379  {
381  if (verb == -1)
382  verb = verbose;
384  // find p_miit
385  ProblemsByName &pRoblems_set = pRoblems.get<Problem_mi_tag>();
386  ProblemsByName::iterator p_miit = pRoblems_set.find(problem_name);
387  if (p_miit == pRoblems_set.end())
388  SETERRQ1(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "problem is not in database %s",
389  problem_name.c_str());
390  CHKERR problem_basic_method_preProcess(&*p_miit, method, verb);
392 }

◆ query_interface()

MoFEMErrorCode MoFEM::Core::query_interface ( boost::typeindex::type_index  type_index,
UnknownInterface **  iface 
) const
virtual

Getting interface of core database.

Parameters
uuidunique ID of interface
ifacereturned pointer to interface
Returns
error code

Implements MoFEM::UnknownInterface.

Definition at line 43 of file Core.cpp.

44  {
46  *iface = NULL;
47  if (type_index == boost::typeindex::type_id<CoreInterface>()) {
48  *iface = static_cast<CoreInterface *>(const_cast<Core *>(this));
50  } else if (type_index ==
51  boost::typeindex::type_id<DeprecatedCoreInterface>()) {
52  *iface = static_cast<DeprecatedCoreInterface *>(const_cast<Core *>(this));
54  }
55 
56  // Get sub-interface
57  auto it = iFaces.find(type_index);
58  if (it != iFaces.end()) {
59  *iface = it->second;
61  }
62 
63  *iface = NULL;
64  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY, "unknown interface");
66 }

◆ rebuild_database()

MoFEMErrorCode MoFEM::Core::rebuild_database ( int  verb = DEFAULT_VERBOSITY)
protectedvirtual

Clear database and initialize it once again.

Parameters
verbVerbosity level
Returns
Error code

Implements MoFEM::CoreInterface.

Definition at line 736 of file Core.cpp.

736  {
738  if (verb == -1)
739  verb = verbose;
740  CHKERR this->clearMap();
741  CHKERR this->getTags(verb);
744 }

◆ regEvents()

template<class IFACE >
MoFEMErrorCode MoFEM::Core::regEvents
protected

Register petsc events.

Template Parameters
IFACE
Returns
MoFEMErrorCode

Definition at line 184 of file Core.cpp.

184  {
186  auto ptr = boost::make_shared<IFACE>();
187  // See SFINAE:
188  // https://stackoverflow.com/questions/257288/is-it-possible-to-write-a-template-to-check-for-a-functions-existence
189  // https://en.wikipedia.org/wiki/Substitution_failure_is_not_an_error
190  auto get_event_options = [](auto *const ptr) {
191  return get_event_options_imp(ptr, 0);
192  };
193  CHKERR get_event_options(ptr.get());
195 }

◆ registerSubInterfaces()

MoFEMErrorCode MoFEM::Core::registerSubInterfaces ( )
protected

Register insterfaces.

Returns
MoFEMErrorCode

Definition at line 463 of file Core.cpp.

463  {
465 
466  iFaces.clear();
467 
468  // Register sub interfaces
469  CHKERR regSubInterface<LogManager>();
470  CHKERR regSubInterface<Simple>();
471  CHKERR regSubInterface<OperatorsTester>();
472  CHKERR regSubInterface<PipelineManager>();
473  CHKERR regSubInterface<ProblemsManager>();
474  CHKERR regSubInterface<MatrixManager>();
475  CHKERR regSubInterface<ISManager>();
476  CHKERR regSubInterface<VecManager>();
477  CHKERR regSubInterface<FieldBlas>();
478  CHKERR regSubInterface<BitRefManager>();
479  CHKERR regSubInterface<Tools>();
480  CHKERR regSubInterface<CommInterface>();
481  CHKERR regSubInterface<MeshsetsManager>();
482  CHKERR regSubInterface<NodeMergerInterface>();
483  CHKERR regSubInterface<PrismsFromSurfaceInterface>();
484  CHKERR regSubInterface<MeshRefinement>();
485  CHKERR regSubInterface<PrismInterface>();
486  CHKERR regSubInterface<CutMeshInterface>();
487  CHKERR regSubInterface<SeriesRecorder>();
488 #ifdef WITH_TETGEN
489  CHKERR regSubInterface<TetGenInterface>();
490 #endif
491 #ifdef WITH_MED
492  CHKERR regSubInterface<MedInterface>();
493 #endif
494  CHKERR regSubInterface<FieldEvaluatorInterface>();
495  CHKERR regSubInterface<BcManager>();
496 
497  // Register events
498  CHKERR regEvents<SchurEvents>();
499 
501 };

◆ regSubInterface()

template<class IFACE >
MoFEMErrorCode MoFEM::Core::regSubInterface
protected

Register sub-interfaces in core interface.

Template Parameters
IFACE
Returns
MoFEMErrorCode

Definition at line 166 of file Core.cpp.

166  {
168  CHKERR registerInterface<IFACE>(true);
169  IFACE *ptr = new IFACE(*this);
170 
171  // If sub interface has function getSubInterfaceOptions run
172  // it after construction. getSubInterfaceOptions is used to
173  // get parameters from command line.
174  auto get_sub_iface_options = [](auto *const ptr) {
175  return get_sub_iface_options_imp(ptr, 0);
176  };
177  CHKERR get_sub_iface_options(ptr);
178 
179  auto type_idx = boost::typeindex::type_id<IFACE>();
180  iFaces.insert(type_idx, ptr);
182 }

◆ remove_ents()

MoFEMErrorCode MoFEM::Core::remove_ents ( const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities form mofem database

Implements MoFEM::CoreInterface.

Definition at line 429 of file DeleteCore.cpp.

429  {
431  if (verb == -1)
432  verb = verbose;
434  CHKERR remove_ents_from_field(ents, verb);
435 
436  for (Range::const_pair_iterator p_eit = ents.pair_begin();
437  p_eit != ents.pair_end(); ++p_eit) {
438 
439  RefElement_multiIndex::index<Ent_mi_tag>::type::iterator frit, hi_frit;
440  frit = refinedFiniteElements.get<Ent_mi_tag>().lower_bound(p_eit->first);
441  hi_frit =
442  refinedFiniteElements.get<Ent_mi_tag>().upper_bound(p_eit->second);
443  refinedFiniteElements.get<Ent_mi_tag>().erase(frit, hi_frit);
444 
445  RefEntity_multiIndex::index<Ent_mi_tag>::type::iterator rit, hi_rit;
446  rit = refinedEntities.get<Ent_mi_tag>().lower_bound(p_eit->first);
447  hi_rit = refinedEntities.get<Ent_mi_tag>().upper_bound(p_eit->second);
448  refinedEntities.get<Ent_mi_tag>().erase(rit, hi_rit);
449  }
450 
452 }

◆ remove_ents_by_bit_ref()

MoFEMErrorCode MoFEM::Core::remove_ents_by_bit_ref ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities form mofem database

Implements MoFEM::CoreInterface.

Definition at line 454 of file DeleteCore.cpp.

455  {
457  if (verb == -1)
458  verb = verbose;
459  Range ents;
460  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
461  CHKERR remove_ents(ents, verb);
463 }

◆ remove_ents_from_field() [1/3]

MoFEMErrorCode MoFEM::Core::remove_ents_from_field ( const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities from all fields

Note
not collective

Implements MoFEM::CoreInterface.

Definition at line 176 of file DeleteCore.cpp.

176  {
178  if (verb == -1)
179  verb = verbose;
180  CHKERR clear_ents_fields(ents, verb);
181  for (Field_multiIndex::iterator fit = fIelds.begin(); fit != fIelds.end();
182  fit++) {
183  EntityHandle meshset = fit->get()->getMeshset();
184  CHKERR get_moab().remove_entities(meshset, ents);
185  }
187 }

◆ remove_ents_from_field() [2/3]

MoFEMErrorCode MoFEM::Core::remove_ents_from_field ( const std::string  name,
const EntityHandle  meshset,
const EntityType  type,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities from field

Note
not collective

Implements MoFEM::CoreInterface.

Definition at line 152 of file DeleteCore.cpp.

154  {
156  if (verb == -1)
157  verb = verbose;
158  Range ents;
159  CHKERR get_moab().get_entities_by_type(meshset, type, ents);
160  CHKERR remove_ents_from_field(name, ents, verb);
162 }

◆ remove_ents_from_field() [3/3]

MoFEMErrorCode MoFEM::Core::remove_ents_from_field ( const std::string  name,
const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities from field

Note
not collective

Implements MoFEM::CoreInterface.

Definition at line 164 of file DeleteCore.cpp.

165  {
167  if (verb == -1)
168  verb = verbose;
169  EntityHandle meshset;
170  meshset = get_field_meshset(name);
171  CHKERR clear_ents_fields(name, ents, verb);
172  CHKERR get_moab().remove_entities(meshset, ents);
174 }

◆ remove_ents_from_field_by_bit_ref()

MoFEMErrorCode MoFEM::Core::remove_ents_from_field_by_bit_ref ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities from field

Note
not collective

Implements MoFEM::CoreInterface.

Definition at line 189 of file DeleteCore.cpp.

191  {
193  if (verb == -1)
194  verb = verbose;
195  Range ents;
196  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
197  CHKERR remove_ents_from_field(ents, verb);
199 }

◆ remove_ents_from_finite_element() [1/3]

MoFEMErrorCode MoFEM::Core::remove_ents_from_finite_element ( const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities from finite elements in database

Implements MoFEM::CoreInterface.

Definition at line 404 of file DeleteCore.cpp.

405  {
407  if (verb == -1)
408  verb = verbose;
409  CHKERR clear_finite_elements(ents, verb);
410  for (FiniteElement_multiIndex::iterator fe_it = finiteElements.begin();
411  fe_it != finiteElements.end(); fe_it++) {
412  EntityHandle meshset = fe_it->get()->getMeshset();
413  CHKERR get_moab().remove_entities(meshset, ents);
414  }
416 }

◆ remove_ents_from_finite_element() [2/3]

MoFEMErrorCode MoFEM::Core::remove_ents_from_finite_element ( const std::string  name,
const EntityHandle  meshset,
const EntityType  type,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities from given refinement level to finite element database

Implements MoFEM::CoreInterface.

Definition at line 379 of file DeleteCore.cpp.

382  {
384  if (verb == -1)
385  verb = verbose;
386  Range ents;
387  CHKERR get_moab().get_entities_by_type(meshset, type, ents, false);
388  CHKERR remove_ents_from_finite_element(name, ents, verb);
390 }

◆ remove_ents_from_finite_element() [3/3]

MoFEMErrorCode MoFEM::Core::remove_ents_from_finite_element ( const std::string  name,
const Range  ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove entities from finite element database

Implements MoFEM::CoreInterface.

Definition at line 392 of file DeleteCore.cpp.

394  {
396  if (verb == -1)
397  verb = verbose;
398  CHKERR clear_finite_elements(name, ents, verb);
399  const EntityHandle idm = get_finite_element_meshset(name);
400  CHKERR get_moab().remove_entities(idm, ents);
402 }

◆ remove_ents_from_finite_element_by_bit_ref()

MoFEMErrorCode MoFEM::Core::remove_ents_from_finite_element_by_bit_ref ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

remove elements from given refinement level to finite element database

Parameters
BitRefLevelbit
BitRefLevelmask
verboselevel

Implements MoFEM::CoreInterface.

Definition at line 418 of file DeleteCore.cpp.

419  {
421  if (verb == -1)
422  verb = verbose;
423  Range ents;
424  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
427 }

◆ remove_parents_by_bit_ref()

MoFEMErrorCode MoFEM::Core::remove_parents_by_bit_ref ( const BitRefLevel  bit,
const BitRefLevel  mask,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Remove parent from entities on bit level.

Evert entity created by refinement, split or any other change on the mesh can have parent. This function remove parent from entity,

Note
Functions makeing topological changes on entities should repsect parents child relation. This erase that relation. If you going to split faces and create interface is recommended to call this function before split opeartion.
Parameters
bitlevel
maskof bit level
verbverbosity level
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Definition at line 465 of file DeleteCore.cpp.

467  {
469  if (verb == -1)
470  verb = verbose;
471  Range ents;
472  CHKERR BitRefManager(*this).getEntitiesByRefLevel(bit, mask, ents, verb);
473  CHKERR remove_parents_by_ents(ents, verb);
475 }

◆ remove_parents_by_ents()

MoFEMErrorCode MoFEM::Core::remove_parents_by_ents ( const Range ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Remove parents from entities.

Implements MoFEM::CoreInterface.

Definition at line 477 of file DeleteCore.cpp.

477  {
479 
480  std::vector<EntityHandle> leftovers_ents;
481  leftovers_ents.reserve(ents.size());
482 
483  for (auto pit = ents.pair_begin(); pit != ents.pair_end(); ++pit) {
484 
485  EntityHandle f = pit->first;
486  const EntityHandle s = pit->second;
487  auto lo = refinedEntities.lower_bound(f);
488  for (; f <= s; ++f) {
489 
490  auto check = [this](auto lo, auto f) {
491  if (lo == refinedEntities.end())
492  return false;
493  if ((*lo)->getEnt() == f)
494  return true;
495  return false;
496  };
497 
498  if (check(lo, f)) {
499  bool success = refinedEntities.modify(lo, RefEntity_change_parent(0));
500  if (!success)
501  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
502  "Operation of removing parent unsuccessful");
503  ++lo;
504  } else
505  leftovers_ents.emplace_back(f);
506  }
507  }
508 
509  if (!leftovers_ents.empty()) {
510  std::vector<EntityHandle> zero_parents(leftovers_ents.size());
511  CHKERR get_moab().tag_set_data(th_RefParentHandle, &leftovers_ents[0],
512  leftovers_ents.size(),
513  &*zero_parents.begin());
514  }
516 }

◆ remove_parents_by_parents()

MoFEMErrorCode MoFEM::Core::remove_parents_by_parents ( const Range ents,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Remove paremts from entities having parents in passed range.

Implements MoFEM::CoreInterface.

Definition at line 518 of file DeleteCore.cpp.

518  {
520  for (Range::iterator eit = ents.begin(); eit != ents.end(); ++eit) {
521  RefEntity_multiIndex::index<Ent_Ent_mi_tag>::type::iterator it;
522  while ((it = refinedEntities.get<Ent_Ent_mi_tag>().find(*eit)) !=
523  refinedEntities.get<Ent_Ent_mi_tag>().end()) {
524  bool success = refinedEntities.get<Ent_Ent_mi_tag>().modify(
525  it, RefEntity_change_parent(0));
526  if (!success) {
527  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
528  "Operation of removing parent unsuccessful");
529  }
530  }
531  }
533 }

◆ set_field_order() [1/4]

MoFEMErrorCode MoFEM::Core::set_field_order ( const EntityHandle  meshset,
const EntityType  type,
const BitFieldId  id,
const ApproximationOrder  order,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 931 of file FieldCore.cpp.

933  {
935  if (verb == -1)
936  verb = verbose;
937  *buildMoFEM = 0;
938  Range ents;
939  CHKERR get_moab().get_entities_by_type(meshset, type, ents);
940  CHKERR this->set_field_order(ents, id, order, verb);
942 }

◆ set_field_order() [2/4]

MoFEMErrorCode MoFEM::Core::set_field_order ( const EntityHandle  meshset,
const EntityType  type,
const std::string &  name,
const ApproximationOrder  order,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Set order approximation of the entities in the field.

Note
not collective
Parameters
meshsetcontaining set of the entities (use 0 for all the entities in the meshset)
typeselected type of the entities f.e. MBTET, MBTRI, MBEDGE, MBVERTEX, see moab documentation
orderapproximation order

Implements MoFEM::CoreInterface.

Definition at line 943 of file FieldCore.cpp.

946  {
948  if (verb == -1)
949  verb = verbose;
950  *buildMoFEM = 0;
951  CHKERR this->set_field_order(meshset, type, get_field_id(name), order, verb);
953 }

◆ set_field_order() [3/4]

MoFEMErrorCode MoFEM::Core::set_field_order ( const Range ents,
const BitFieldId  id,
const ApproximationOrder  order,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 906 of file FieldCore.cpp.

907  {
908  MOFEM_LOG_CHANNEL("WORLD");
909  MOFEM_LOG_TAG("WORLD", "FieldCore");
910  MOFEM_LOG_CHANNEL("SYNC");
911  MOFEM_LOG_TAG("SYNC", "FieldCore");
914 
915  // check field & meshset
916  auto field_it = fIelds.get<BitFieldId_mi_tag>().find(id);
917  if (field_it == fIelds.get<BitFieldId_mi_tag>().end())
918  SETERRQ(PETSC_COMM_SELF, MOFEM_NOT_FOUND, "no filed found");
919 
920  MOFEM_LOG("WORLD", Sev::noisy)
921  << "Field " << (*field_it)->getName() << " core value < "
922  << this->getValue() << " > field value ( "
923  << static_cast<int>((*field_it)->getBitNumber()) << " )"
924  << " nb. of ents " << ents.size();
925 
926  CHKERR this->setFieldOrderImpl(*field_it, ents, order, verb);
927 
929 }

◆ set_field_order() [4/4]

MoFEMErrorCode MoFEM::Core::set_field_order ( const Range ents,
const std::string &  name,
const ApproximationOrder  order,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Set order approximation of the entities in the field.

Note
not collective
Parameters
entities
typeselected type of the entities f.e. MBTET, MBTRI, MBEDGE, MBVERTEX, see moab documentation
orderapproximation order

Implements MoFEM::CoreInterface.

Definition at line 954 of file FieldCore.cpp.

955  {
957  if (verb == -1)
958  verb = verbose;
959  *buildMoFEM = 0;
960  CHKERR this->set_field_order(ents, get_field_id(name), order, verb);
962 }

◆ set_field_order_by_entity_type_and_bit_ref() [1/2]

MoFEMErrorCode MoFEM::Core::set_field_order_by_entity_type_and_bit_ref ( const BitRefLevel bit,
const BitRefLevel mask,
const EntityType  type,
const BitFieldId  id,
const ApproximationOrder  order,
int  verb = DEFAULT_VERBOSITY 
)
protected

Definition at line 963 of file FieldCore.cpp.

965  {
967  if (verb == -1)
968  verb = verbose;
969  *buildMoFEM = 0;
970  Range ents;
971  CHKERR BitRefManager(*this).getEntitiesByTypeAndRefLevel(bit, mask, type,
972  ents, verb);
973  CHKERR this->set_field_order(ents, id, order, verb);
975 }

◆ set_field_order_by_entity_type_and_bit_ref() [2/2]

MoFEMErrorCode MoFEM::Core::set_field_order_by_entity_type_and_bit_ref ( const BitRefLevel bit,
const BitRefLevel mask,
const EntityType  type,
const std::string &  name,
const ApproximationOrder  order,
int  verb = DEFAULT_VERBOSITY 
)
protectedvirtual

Set order approximation of the entities in the field.

Note
not collective
Parameters
bitrefinement level
maskbit mask
typeselected type of the entities f.e. MBTET, MBTRI, MBEDGE, MBVERTEX, see moab documentation
orderapproximation order

Implements MoFEM::CoreInterface.

Definition at line 977 of file FieldCore.cpp.

979  {
981  if (verb == -1)
982  verb = verbose;
983  *buildMoFEM = 0;
984  Range ents;
985  CHKERR BitRefManager(*this).getEntitiesByTypeAndRefLevel(bit, mask, type,
986  ents, verb);
987  CHKERR this->set_field_order(ents, get_field_id(name), order, verb);
989 }

◆ set_moab_interface()

MoFEMErrorCode MoFEM::Core::set_moab_interface ( moab::Interface &  new_moab,
int  verb = VERBOSE 
)
protectedvirtual

Set the moab interface object.

Parameters
new_moab
verb
Returns
MoFEMErrorCode

Implements MoFEM::CoreInterface.

Reimplemented in MoFEM::CoreTmp<-1 >.

Definition at line 746 of file Core.cpp.

746  {
747  return this->setMoabInterface(new_moab, verb);
748 };

◆ setFieldOrder()

MoFEMErrorCode MoFEM::CoreTmp< 0 >::setFieldOrder ( const Range ents,
const BitFieldId  id,
const ApproximationOrder  order,
int  ver 
)
protected

◆ setFieldOrderImpl()

MoFEMErrorCode MoFEM::Core::setFieldOrderImpl ( boost::shared_ptr< Field field_ptr,
const Range ents,
const ApproximationOrder  order,
int  verb 
)
protected

Definition at line 482 of file FieldCore.cpp.

485  {
487 
488  if (verb == DEFAULT_VERBOSITY)
489  verb = verbose;
490  *buildMoFEM = 0;
491 
492  const auto field_meshset = field_ptr->getMeshset();
493  const auto bit_number = field_ptr->getBitNumber();
494 
495  // intersection with field meshset
496  Range ents_of_id_meshset;
497  CHKERR get_moab().get_entities_by_handle(field_meshset, ents_of_id_meshset,
498  false);
499  Range field_ents = intersect(ents, ents_of_id_meshset);
500  if (verb > QUIET) {
501  MOFEM_LOG_C("SYNC", Sev::noisy,
502  "change nb. of ents for order in the field <%s> %d",
503  field_ptr->getName().c_str(), field_ents.size(), ents.size());
504  }
505 
506  // ent view by field id (in set all MoabEnts has the same FieldId)
507  auto eiit = entsFields.get<Unique_mi_tag>().lower_bound(
508  FieldEntity::getLoBitNumberUId(field_ptr->getBitNumber()));
509  FieldEntity_multiIndex_ent_view ents_id_view;
510  if (eiit != entsFields.get<Unique_mi_tag>().end()) {
511  auto hi_eiit = entsFields.get<Unique_mi_tag>().upper_bound(
512  FieldEntity::getHiBitNumberUId(field_ptr->getBitNumber()));
513  std::copy(eiit, hi_eiit, std::back_inserter(ents_id_view));
514  }
515 
516  if (verb > QUIET)
517  MOFEM_LOG_C("SYNC", Sev::noisy,
518  "current nb. of ents in the multi index field <%s> %d",
519  field_ptr->getName().c_str(), ents_id_view.size());
520 
521  // loop over ents
522  int nb_ents_set_order_up = 0;
523  int nb_ents_set_order_down = 0;
524  int nb_ents_set_order_new = 0;
525 
526  FieldEntity_change_order modify_order_no_size_change(order, false);
527  FieldEntity_change_order modify_order_size_change(order, true);
528 
529  for (auto pit = field_ents.const_pair_begin();
530  pit != field_ents.const_pair_end(); pit++) {
531  EntityHandle first = pit->first;
532  EntityHandle second = pit->second;
533 
534  const auto type = static_cast<EntityType>(first >> MB_ID_WIDTH);
535 
536  // Sanity check
537  switch (field_ptr->getSpace()) {
538  case H1:
539  break;
540  case HCURL:
541  if (type == MBVERTEX)
542  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
543  "Hcurl space on vertices makes no sense");
544 
545  break;
546  case HDIV:
547  if (type == MBVERTEX)
548  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
549  "Hdiv space on vertices makes no sense");
550 
551  if (type == MBEDGE)
552  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
553  "Hdiv space on edges makes no sense");
554 
555  break;
556  default:
557  break;
558  }
559 
560  // Entity is in database, change order only if needed
561  Range ents_in_database;
562  auto vit = ents_id_view.get<1>().lower_bound(first);
563  auto hi_vit = ents_id_view.get<1>().upper_bound(second);
564  if (order >= 0) {
565  for (; vit != hi_vit; ++vit) {
566  ents_in_database.insert(vit->get()->getEnt());
567  // entity is in database and order is changed or reset
568  const ApproximationOrder old_approximation_order =
569  (*vit)->getMaxOrder();
570 
571  if (old_approximation_order != order) {
572 
573  FieldEntity_multiIndex::iterator miit =
574  entsFields.get<Unique_mi_tag>().find((*vit)->getLocalUniqueId());
575 
576  if ((*miit)->getMaxOrder() < order)
577  nb_ents_set_order_up++;
578  if ((*miit)->getMaxOrder() > order)
579  nb_ents_set_order_down++;
580 
581  // set dofs inactive if order is reduced, and set new order to entity
582  // if order is increased (note that dofs are not build if order is
583  // increased)
584 
585  bool can_change_size = true;
586  auto dit = dofsField.get<Unique_mi_tag>().lower_bound(
588  (*miit)->getEnt()));
589  if (dit != dofsField.get<Unique_mi_tag>().end()) {
590  auto hi_dit = dofsField.get<Unique_mi_tag>().upper_bound(
592  (*miit)->getEnt()));
593 
594  if (dit != hi_dit)
595  can_change_size = false;
596  for (; dit != hi_dit; dit++) {
597  if ((*dit)->getDofOrder() > order) {
598  bool success = dofsField.modify(dofsField.project<0>(dit),
599  DofEntity_active_change(false));
600  if (!success)
601  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
602  "modification unsuccessful");
603  }
604  }
605  }
606 
607  bool success =
608  entsFields.modify(entsFields.project<0>(miit),
609  can_change_size ? modify_order_size_change
610  : modify_order_no_size_change);
611  if (!success)
612  SETERRQ(PETSC_COMM_SELF, MOFEM_OPERATION_UNSUCCESSFUL,
613  "modification unsuccessful");
614  }
615  }
616  }
617 
618  Range new_ents = subtract(Range(first, second), ents_in_database);
619  for (Range::const_pair_iterator pit = new_ents.const_pair_begin();
620  pit != new_ents.const_pair_end(); ++pit) {
621  const auto first = pit->first;
622  const auto second = pit->second;
623  const auto ent_type = get_moab().type_from_handle(first);
624 
625  if (!field_ptr->getFieldOrderTable()[ent_type])
626  SETERRQ3(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
627  "Number of degrees of freedom for entity %s for %s space on "
628  "base %s can "
629  "not be deduced",
630  moab::CN::EntityTypeName(ent_type),
631  field_ptr->getSpaceName().c_str(),
632  field_ptr->getApproxBaseName().c_str());
633 
634  auto get_nb_dofs_on_order = [&](const int order) {
635  return order >= 0 ? (field_ptr->getFieldOrderTable()[ent_type])(order)
636  : 0;
637  };
638  const int nb_dofs_on_order = get_nb_dofs_on_order(order);
639  if (nb_dofs_on_order || order == -1) {
640 
641  const int field_rank = field_ptr->getNbOfCoeffs();
642  const int nb_dofs = nb_dofs_on_order * field_rank;
643 
644  // Entity is not in database and order is changed or reset
645  auto miit_ref_ent =
646  refinedEntities.get<Ent_mi_tag>().lower_bound(first);
647 
648  auto create_tags_for_max_order = [&](const Range &ents) {
650  if (order >= 0) {
651  std::vector<ApproximationOrder> o_vec(ents.size(), order);
652  CHKERR get_moab().tag_set_data(field_ptr->th_AppOrder, ents,
653  &*o_vec.begin());
654  }
656  };
657 
658  auto create_tags_for_data = [&](const Range &ents) {
660  if (order >= 0) {
661 
662  if (nb_dofs > 0) {
663  if (ent_type == MBVERTEX) {
664  std::vector<FieldData> d_vec(nb_dofs * ents.size(), 0);
665  CHKERR get_moab().tag_set_data(field_ptr->th_FieldDataVerts,
666  ents, &*d_vec.begin());
667  } else {
668  std::vector<int> tag_size(ents.size(), nb_dofs);
669  std::vector<FieldData> d_vec(nb_dofs, 0);
670  std::vector<void const *> d_vec_ptr(ents.size(),
671  &*d_vec.begin());
672  CHKERR get_moab().tag_set_by_ptr(field_ptr->th_FieldData, ents,
673  &*d_vec_ptr.begin(),
674  &*tag_size.begin());
675  }
676  }
677  }
678 
680  };
681 
682  auto get_ents_in_ref_ent = [&](auto miit_ref_ent) {
683  auto hi = refinedEntities.get<Ent_mi_tag>().upper_bound(second);
684  Range in;
685  for (; miit_ref_ent != hi; ++miit_ref_ent)
686  in.insert(miit_ref_ent->get()->getEnt());
687  return in;
688  };
689 
690  auto get_ents_max_order = [&](const Range &ents) {
691  boost::shared_ptr<std::vector<const void *>> vec(
692  new std::vector<const void *>());
693  vec->resize(ents.size());
694  CHKERR get_moab().tag_get_by_ptr(field_ptr->th_AppOrder, ents,
695  &*vec->begin());
696  return vec;
697  };
698 
699  auto get_ents_field_data_vector_adaptor =
700  [&](const Range &ents,
701  boost::shared_ptr<std::vector<const void *>> &ents_max_orders) {
702  // create shared pointer and reserve memory
703  boost::shared_ptr<std::vector<double *>> vec(
704  new std::vector<double *>());
705  vec->reserve(ents.size());
706 
707  if (order >= 0 && nb_dofs == 0) {
708  // set empty vector adaptor
709  for (int i = 0; i != ents.size(); ++i)
710  vec->emplace_back(nullptr);
711  } else {
712  moab::ErrorCode rval;
713  std::vector<int> tag_size(ents.size());
714  std::vector<const void *> d_vec_ptr(ents.size());
715 
716  // get tags data
717  if (ent_type == MBVERTEX)
718  rval = get_moab().tag_get_by_ptr(field_ptr->th_FieldDataVerts,
719  ents, &*d_vec_ptr.begin(),
720  &*tag_size.begin());
721  else
722  rval = get_moab().tag_get_by_ptr(field_ptr->th_FieldData,
723  ents, &*d_vec_ptr.begin(),
724  &*tag_size.begin());
725 
726  auto cast = [](auto p) {
727  return const_cast<FieldData *const>(
728  static_cast<const FieldData *>(p));
729  };
730 
731  // some of entities has tag not set or zero dofs on entity
732  if (rval == MB_SUCCESS) {
733  // all is ok, all entities has tag set
734  auto tit = d_vec_ptr.begin();
735  auto oit = ents_max_orders->begin();
736  for (auto sit = tag_size.begin(); sit != tag_size.end();
737  ++sit, ++tit, ++oit)
738  vec->emplace_back(cast(*tit));
739 
740  } else {
741  // set empty vector adaptor
742  for (int i = 0; i != ents.size(); ++i)
743  vec->emplace_back(nullptr);
744 
745  // check order on all entities, and if for that order non zero
746  // dofs are expected get pointer to tag data and reset vector
747  // adaptor
748  auto oit = ents_max_orders->begin();
749  auto dit = vec->begin();
750  for (auto eit = ents.begin(); eit != ents.end();
751  ++eit, ++oit, ++dit) {
752 
753  const int ent_order =
754  *static_cast<const ApproximationOrder *>(*oit);
755  const int ent_nb_dofs = get_nb_dofs_on_order(ent_order);
756 
757  if (ent_nb_dofs) {
758  int tag_size;
759  const void *ret_val;
760  if (ent_type == MBVERTEX) {
761  rval = get_moab().tag_get_by_ptr(
762  field_ptr->th_FieldDataVerts, &*eit, 1, &ret_val,
763  &tag_size);
764  } else {
765  rval = get_moab().tag_get_by_ptr(
766  field_ptr->th_FieldData, &*eit, 1, &ret_val,
767  &tag_size);
768  if (rval != MB_SUCCESS) {
769 
770  const int set_tag_size[] = {ent_nb_dofs * field_rank};
771  std::array<FieldData, MAX_DOFS_ON_ENTITY> set_d_vec;
772  std::fill(set_d_vec.begin(),
773  &set_d_vec[set_tag_size[0]], 0);
774  const void *set_d_vec_ptr[] = {set_d_vec.data()};
775  CHKERR get_moab().tag_set_by_ptr(
776  field_ptr->th_FieldData, &*eit, 1, set_d_vec_ptr,
777  set_tag_size);
778  rval = get_moab().tag_get_by_ptr(
779  field_ptr->th_FieldData, &*eit, 1, &ret_val,
780  &tag_size);
781 
782  if (rval != MB_SUCCESS) {
783  MOFEM_LOG_ATTRIBUTES("SELF",
786  MOFEM_LOG("SELF", Sev::error)
787  << "Error is triggered in MOAB, field tag data "
788  "for same reason can not be for accessed.";
789  MOFEM_LOG("SELF", Sev::error)
790  << "Set order: " << order;
791  MOFEM_LOG("SELF", Sev::error)
792  << "Nb. dofs on entity for given order: "
793  << set_tag_size[0];
794  MOFEM_LOG("SELF", Sev::error)
795  << "Entity type: "
796  << moab::CN::EntityTypeName(ent_type);
797  MOFEM_LOG("SELF", Sev::error)
798  << "Field: " << *field_ptr;
799  CHKERR rval;
800  }
801  }
802  }
803  const_cast<FieldData *&>(*dit) = cast(ret_val);
804  }
805  }
806  }
807  }
808  return vec;
809  };
810 
811  auto ents_in_ref_ent = get_ents_in_ref_ent(miit_ref_ent);
812 
813  CHKERR create_tags_for_max_order(ents_in_ref_ent);
814  CHKERR create_tags_for_data(ents_in_ref_ent);
815  auto ents_max_order = get_ents_max_order(ents_in_ref_ent);
816  auto ent_field_data =
817  get_ents_field_data_vector_adaptor(ents_in_ref_ent, ents_max_order);
818 
819  // reserve memory for field dofs
820  auto ents_array = boost::make_shared<std::vector<FieldEntity>>();
821  // Add sequence to field data structure. Note that entities are
822  // allocated once into vector. This vector is passed into sequence as a
823  // weak_ptr. Vector is destroyed at the point last entity inside that
824  // vector is destroyed.
825  ents_array->reserve(second - first + 1);
826  auto vit_max_order = ents_max_order->begin();
827  auto vit_field_data = ent_field_data->begin();
828  for (int i = 0; i != ents_in_ref_ent.size(); ++i) {
829 
830  ents_array->emplace_back(
831  field_ptr, *miit_ref_ent,
832  boost::shared_ptr<double *const>(ent_field_data,
833  &*vit_field_data),
834  boost::shared_ptr<const int>(
835  ents_max_order, static_cast<const int *>(*vit_max_order)));
836  ++vit_max_order;
837  ++vit_field_data;
838  ++miit_ref_ent;
839  }
840  if (!ents_array->empty())
841  if ((*ents_array)[0].getFieldRawPtr() != field_ptr.get())
842  SETERRQ1(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
843  "Get field ent poiter and field pointer do not match for "
844  "field %s",
845  field_ptr->getName().c_str());
846  nb_ents_set_order_new += ents_array->size();
847 
848  // Check if any of entities in the range has bit level but is not added
849  // to database. That generate data inconsistency and error.
850  if (ents_in_ref_ent.size() < (second - first + 1)) {
851  Range ents_not_in_database =
852  subtract(Range(first, second), ents_in_ref_ent);
853  std::vector<const void *> vec_bits(ents_not_in_database.size());
854  CHKERR get_moab().tag_get_by_ptr(
855  get_basic_entity_data_ptr()->th_RefBitLevel, ents_not_in_database,
856  &*vec_bits.begin());
857  auto cast = [](auto p) {
858  return static_cast<const BitRefLevel *>(p);
859  };
860  for (auto v : vec_bits)
861  if (cast(v)->any())
862  SETERRQ(PETSC_COMM_SELF, MOFEM_DATA_INCONSISTENCY,
863  "Try to add entities which are not seeded or added to "
864  "database");
865  }
866 
867  // Add entities to database
868  auto hint = entsFields.end();
869  for (auto &v : *ents_array)
870  hint = entsFields.emplace_hint(hint, ents_array, &v);
871  }
872  }
873  }
874 
875  if (verb > QUIET) {
876  MOFEM_LOG_C("SYNC", Sev::noisy,
877  "nb. of entities in field <%s> for which order was "
878  "increased %d (order %d)",
879  field_ptr->getName().c_str(), nb_ents_set_order_up, order);
880  MOFEM_LOG_C("SYNC", Sev::noisy,
881  "nb. of entities in field <%s> for which order was "
882  "reduced %d (order %d)",
883  field_ptr->getName().c_str(), nb_ents_set_order_down, order);
884  MOFEM_LOG_C(
885  "SYNC", Sev::noisy,
886  "nb. of entities in field <%s> for which order set %d (order %d)",
887  field_ptr->getName().c_str(), nb_ents_set_order_new, order);
888  }
889 
890  if (verb > QUIET) {
891  auto eiit = entsFields.get<Unique_mi_tag>().lower_bound(
892  FieldEntity::getLoBitNumberUId(field_ptr->getBitNumber()));
893  auto hi_eiit = entsFields.get<Unique_mi_tag>().upper_bound(
894  FieldEntity::getHiBitNumberUId(field_ptr->getBitNumber()));
895  MOFEM_LOG_C("SYNC", Sev::noisy,
896  "nb. of ents in the multi index field <%s> %d",
897  field_ptr->getName().c_str(), std::distance(eiit, hi_eiit));
898  }
899 
900  if (verb > QUIET)
901  MOFEM_LOG_SEVERITY_SYNC(mofemComm, Sev::noisy);
902 
904 }

◆ setMoabInterface()

MoFEMErrorCode MoFEM::Core::setMoabInterface ( moab::Interface &  new_moab,
int  verb = VERBOSE 
)
protected

Definition at line 433 of file Core.cpp.

433  {
435  if (verb == -1)
436  verb = verbose;
437 
438  // clear moab database
439  CHKERR clearMap();
440 
441  // set new reference
442  moab = std::ref(new_moab);
443 
444  // check if moab has set communicator if not set communicator internally
445  ParallelComm *pComm = ParallelComm::get_pcomm(&new_moab, MYPCOMM_INDEX);
446  if (pComm == NULL) {
447  pComm = new ParallelComm(&new_moab, wrapMPIMOABComm->get_comm());
448  }
449 
450  // create MoFEM tags
451  CHKERR getTags();
452 
453  // Create basic entity data struture
454  basicEntityDataPtr = boost::make_shared<BasicEntityData>(moab);
456 
457  // Initalise database
459 
461 };

◆ setRefEntBasicDataPtr()

void MoFEM::Core::setRefEntBasicDataPtr ( MoFEM::Interface m_field,
boost::shared_ptr< BasicEntityData > &  ptr 
)
static

Definition at line 909 of file Core.cpp.

910  {
911 
912  switch (m_field.getValue()) {
913  case -1:
915  break;
916  case 0:
917  set_ref_ent_basic_data_ptr_impl<0>(ptr);
918  break;
919  case 1:
920  set_ref_ent_basic_data_ptr_impl<1>(ptr);
921  break;
922  default:
923  THROW_MESSAGE("Core index can vary from -1 to MAX_CORE_TMP");
924  }
925 };

Member Data Documentation

◆ basicEntityDataPtr

boost::shared_ptr<BasicEntityData> MoFEM::CoreTmp< 0 >::basicEntityDataPtr
protected
Returns
pointer to BasicEntityData structure

BasicEntityData is structure which every BasicEntity have. It keeps data about tags to handles on the mesh, in particular tag to BitRefLevel and tag with handle to parent.

Definition at line 281 of file Core.hpp.

◆ buildMoFEM

int* MoFEM::CoreTmp< 0 >::buildMoFEM
mutableprotected

keeps flags/semaphores for different stages

Definition at line 1038 of file Core.hpp.

◆ dofsField

DofEntity_multiIndex MoFEM::CoreTmp< 0 >::dofsField
protected

dofs on fields

Definition at line 305 of file Core.hpp.

◆ entFEAdjacencies

adjacencies of elements to dofs

Definition at line 311 of file Core.hpp.

◆ entsFields

FieldEntity_multiIndex MoFEM::CoreTmp< 0 >::entsFields
protected

entities on fields

Definition at line 304 of file Core.hpp.

◆ entsFiniteElements

EntFiniteElement_multiIndex MoFEM::CoreTmp< 0 >::entsFiniteElements
protected

finite element entities

Definition at line 308 of file Core.hpp.

◆ fIelds

Field_multiIndex MoFEM::CoreTmp< 0 >::fIelds
protected

fields

Definition at line 303 of file Core.hpp.

◆ finiteElements

FiniteElement_multiIndex MoFEM::CoreTmp< 0 >::finiteElements
protected

finite elements

Definition at line 307 of file Core.hpp.

◆ iFaces

boost::ptr_map<boost::typeindex::type_index, UnknownInterface> MoFEM::CoreTmp< 0 >::iFaces
mutableprotected

Hash map of pointers to interfaces.

Definition at line 1036 of file Core.hpp.

◆ initaliseAndBuildField

PetscBool MoFEM::CoreTmp< 0 >::initaliseAndBuildField
protected

If true build field on database initialisation

Definition at line 1042 of file Core.hpp.

◆ initaliseAndBuildFiniteElements

PetscBool MoFEM::CoreTmp< 0 >::initaliseAndBuildFiniteElements
protected

Definition at line 1045 of file Core.hpp.

◆ isGloballyInitialised

bool MoFEM::Core::isGloballyInitialised = false
staticprotected

Core base globally initialized.

Definition at line 1048 of file Core.hpp.

◆ isInitialized

PetscBool MoFEM::Core::isInitialized
staticprotected

petsc was initialised by other agent

Definition at line 1050 of file Core.hpp.

◆ moab

std::reference_wrapper<moab::Interface> MoFEM::CoreTmp< 0 >::moab
protected

moab database

Definition at line 321 of file Core.hpp.

◆ MOFEM_EVENT_createMat

PetscLogEvent MoFEM::CoreTmp< 0 >::MOFEM_EVENT_createMat
protected

Definition at line 996 of file Core.hpp.

◆ MOFEM_EVENT_operator

PetscLogEvent MoFEM::CoreTmp< 0 >::MOFEM_EVENT_operator
protected

Event for evaluating operator of finite element.

Definition at line 993 of file Core.hpp.

◆ MOFEM_EVENT_postProcess

PetscLogEvent MoFEM::CoreTmp< 0 >::MOFEM_EVENT_postProcess
protected

Event for postProcess finite element.

Definition at line 995 of file Core.hpp.

◆ MOFEM_EVENT_preProcess

PetscLogEvent MoFEM::CoreTmp< 0 >::MOFEM_EVENT_preProcess
protected

Event for preProcess finite element.

Definition at line 991 of file Core.hpp.

◆ mofemComm

MPI_Comm MoFEM::CoreTmp< 0 >::mofemComm
mutableprotected

MoFEM communicator.

Definition at line 1004 of file Core.hpp.

◆ mpiInitialised

int MoFEM::Core::mpiInitialised
staticprotected

mpi was initialised by other agent

Definition at line 1049 of file Core.hpp.

◆ optionsPrefix

std::string MoFEM::CoreTmp< 0 >::optionsPrefix
protected

Prefix for options on command line.

Definition at line 1040 of file Core.hpp.

◆ pComm

ParallelComm* MoFEM::CoreTmp< 0 >::pComm
mutableprotected

MOAB communicator structure.

Definition at line 1005 of file Core.hpp.

◆ pRoblems

Problem_multiIndex MoFEM::CoreTmp< 0 >::pRoblems
protected

problems multi-index

Definition at line 313 of file Core.hpp.

◆ rAnk

int MoFEM::CoreTmp< 0 >::rAnk
protected

MOFEM communicator rank.

Definition at line 1008 of file Core.hpp.

◆ refinedEntities

RefEntity_multiIndex MoFEM::CoreTmp< 0 >::refinedEntities
protected

refined entities

Definition at line 300 of file Core.hpp.

◆ refinedFiniteElements

RefElement_multiIndex MoFEM::CoreTmp< 0 >::refinedFiniteElements
protected

refined elements

Definition at line 301 of file Core.hpp.

◆ sIze

int MoFEM::CoreTmp< 0 >::sIze
protected

MoFEM communicator size.

Definition at line 1007 of file Core.hpp.

◆ th_ElemType

Tag MoFEM::CoreTmp< 0 >::th_ElemType
protected

Needed for VTK files.

Definition at line 269 of file Core.hpp.

◆ th_FEId

Tag MoFEM::CoreTmp< 0 >::th_FEId
protected

Definition at line 262 of file Core.hpp.

◆ th_FEIdCol

Tag MoFEM::CoreTmp< 0 >::th_FEIdCol
protected

Definition at line 263 of file Core.hpp.

◆ th_FEIdData

Tag MoFEM::CoreTmp< 0 >::th_FEIdData
protected

Definition at line 263 of file Core.hpp.

◆ th_FEIdRow

Tag MoFEM::CoreTmp< 0 >::th_FEIdRow
protected

Definition at line 263 of file Core.hpp.

◆ th_FEName

Tag MoFEM::CoreTmp< 0 >::th_FEName
protected

Definition at line 262 of file Core.hpp.

◆ th_FieldBase

Tag MoFEM::CoreTmp< 0 >::th_FieldBase
protected

Definition at line 261 of file Core.hpp.

◆ th_FieldContinuity

Tag MoFEM::CoreTmp< 0 >::th_FieldContinuity
protected

Definition at line 261 of file Core.hpp.

◆ th_FieldId

Tag MoFEM::CoreTmp< 0 >::th_FieldId
protected

Definition at line 260 of file Core.hpp.

◆ th_FieldName

Tag MoFEM::CoreTmp< 0 >::th_FieldName
protected

Definition at line 260 of file Core.hpp.

◆ th_FieldName_DataNamePrefix

Tag MoFEM::CoreTmp< 0 >::th_FieldName_DataNamePrefix
protected

Definition at line 260 of file Core.hpp.

◆ th_FieldSpace

Tag MoFEM::CoreTmp< 0 >::th_FieldSpace
protected

Definition at line 260 of file Core.hpp.

◆ th_MoFEMBuild

Tag MoFEM::CoreTmp< 0 >::th_MoFEMBuild
protected

Internal use storing state, used to detect error and inconsistencies

Definition at line 270 of file Core.hpp.

◆ th_Part

Tag MoFEM::CoreTmp< 0 >::th_Part
protected

Tag for partition number.

Definition at line 257 of file Core.hpp.

◆ th_ProblemFEId

Tag MoFEM::CoreTmp< 0 >::th_ProblemFEId
protected

Definition at line 264 of file Core.hpp.

◆ th_ProblemGhostNbDofCol

Tag MoFEM::CoreTmp< 0 >::th_ProblemGhostNbDofCol
protected

Definition at line 267 of file Core.hpp.

◆ th_ProblemGhostNbDofRow

Tag MoFEM::CoreTmp< 0 >::th_ProblemGhostNbDofRow
protected

Definition at line 266 of file Core.hpp.

◆ th_ProblemId

Tag MoFEM::CoreTmp< 0 >::th_ProblemId
protected

Definition at line 264 of file Core.hpp.

◆ th_ProblemLocalNbDofCol

Tag MoFEM::CoreTmp< 0 >::th_ProblemLocalNbDofCol
protected

Definition at line 267 of file Core.hpp.

◆ th_ProblemLocalNbDofRow

Tag MoFEM::CoreTmp< 0 >::th_ProblemLocalNbDofRow
protected

Definition at line 266 of file Core.hpp.

◆ th_ProblemName

Tag MoFEM::CoreTmp< 0 >::th_ProblemName
protected

Definition at line 264 of file Core.hpp.

◆ th_ProblemNbDofsCol

Tag MoFEM::CoreTmp< 0 >::th_ProblemNbDofsCol
protected

Definition at line 265 of file Core.hpp.

◆ th_ProblemNbDofsRow

Tag MoFEM::CoreTmp< 0 >::th_ProblemNbDofsRow
protected

Definition at line 265 of file Core.hpp.

◆ th_ProblemShift

Tag MoFEM::CoreTmp< 0 >::th_ProblemShift
protected

Definition at line 268 of file Core.hpp.

◆ th_RefBitEdge

Tag MoFEM::CoreTmp< 0 >::th_RefBitEdge
protected

Definition at line 258 of file Core.hpp.

◆ th_RefBitLevel

Tag MoFEM::CoreTmp< 0 >::th_RefBitLevel
protected

Definition at line 258 of file Core.hpp.

◆ th_RefBitLevel_Mask

Tag MoFEM::CoreTmp< 0 >::th_RefBitLevel_Mask
protected

Definition at line 258 of file Core.hpp.

◆ th_RefFEMeshset

Tag MoFEM::CoreTmp< 0 >::th_RefFEMeshset
protected

Definition at line 259 of file Core.hpp.

◆ th_RefParentHandle

Tag MoFEM::CoreTmp< 0 >::th_RefParentHandle
protected

Definition at line 258 of file Core.hpp.

◆ value

constexpr const int MoFEM::CoreTmp< 0 >::value = 0
staticconstexpr

Definition at line 84 of file Core.hpp.

◆ verbose

int MoFEM::CoreTmp< 0 >::verbose
protected

Verbosity level.

Definition at line 1031 of file Core.hpp.

◆ wrapMPIMOABComm

boost::shared_ptr<WrapMPIComm> MoFEM::CoreTmp< 0 >::wrapMPIMOABComm
protected

manage creation and destruction of MOAB communicator

Definition at line 1029 of file Core.hpp.


The documentation for this struct was generated from the following files:
NOSPACE
@ NOSPACE
Definition: definitions.h:83
MoFEMFunctionReturnHot
#define MoFEMFunctionReturnHot(a)
Last executable line of each PETSc function used for error handling. Replaces return()
Definition: definitions.h:460
CHK_MOAB_THROW
#define CHK_MOAB_THROW(err, msg)
Check error code of MoAB function and throw MoFEM exception.
Definition: definitions.h:589
DEFAULT_VERBOSITY
@ DEFAULT_VERBOSITY
Definition: definitions.h:220
MoFEM::CoreTmp< 0 >::get_meshsets_manager_ptr
MeshsetsManager * get_meshsets_manager_ptr()
get MeshsetsManager pointer
Definition: Core.cpp:849
MoFEM::CoreTmp< 0 >::getOptions
MoFEMErrorCode getOptions(int verb=DEFAULT_VERBOSITY)
Get core options from command line.
Definition: Core.cpp:755
MoFEM::CoreTmp< 0 >::setFieldOrderImpl
MoFEMErrorCode setFieldOrderImpl(boost::shared_ptr< Field > field_ptr, const Range &ents, const ApproximationOrder order, int verb)
Definition: FieldCore.cpp:482
MoFEM::CoreTmp< 0 >::setMoabInterface
MoFEMErrorCode setMoabInterface(moab::Interface &new_moab, int verb=VERBOSE)
Definition: Core.cpp:433
MoFEM::CoreTmp< 0 >::MOFEM_EVENT_operator
PetscLogEvent MOFEM_EVENT_operator
Event for evaluating operator of finite element.
Definition: Core.hpp:993
MYPCOMM_INDEX
#define MYPCOMM_INDEX
default communicator number PCOMM
Definition: definitions.h:228
MoFEM::CoreTmp< 0 >::build_fields
MoFEMErrorCode build_fields(int verb=DEFAULT_VERBOSITY)
Definition: FieldCore.cpp:1294
MoFEM::CoreTmp< 0 >
Core (interface) class.
Definition: Core.hpp:82
H1
@ H1
continuous field
Definition: definitions.h:85
MoFEM::FieldEntity_multiIndex_ent_view
multi_index_container< boost::shared_ptr< FieldEntity >, indexed_by< sequenced<>, ordered_non_unique< tag< Ent_mi_tag >, const_mem_fun< FieldEntity::interface_type_RefEntity, EntityHandle, &FieldEntity::getEnt > > > > FieldEntity_multiIndex_ent_view
Definition: FieldEntsMultiIndices.hpp:456
MOFEM_LOG_SEVERITY_SYNC
#define MOFEM_LOG_SEVERITY_SYNC(comm, severity)
Synchronise "SYNC" on curtain severity level.
Definition: LogManager.hpp:352
LASTBASE
@ LASTBASE
Definition: definitions.h:69
MoFEM::CoreTmp< 0 >::registerSubInterfaces
MoFEMErrorCode registerSubInterfaces()
Register insterfaces.
Definition: Core.cpp:463
BITFEID_SIZE
#define BITFEID_SIZE
max number of finite elements
Definition: definitions.h:234
MOFEM_LOG_CHANNEL
#define MOFEM_LOG_CHANNEL(channel)
Set and reset channel.
Definition: LogManager.hpp:284
EntityHandle
MoFEM::LogManager::getLog
static LoggerType & getLog(const std::string channel)
Get logger by channel.
Definition: LogManager.cpp:395
MoFEM::CoreTmp< 0 >::th_FEIdData
Tag th_FEIdData
Definition: Core.hpp:263
MoFEM::CoreTmp< 0 >::rAnk
int rAnk
MOFEM communicator rank.
Definition: Core.hpp:1008
MoFEM::CoreTmp< 0 >::remove_parents_by_parents
MoFEMErrorCode remove_parents_by_parents(const Range &ents, int verb=DEFAULT_VERBOSITY)
Remove paremts from entities having parents in passed range.
Definition: DeleteCore.cpp:518
MoFEM::CoreTmp< 0 >::build_finite_elements
MoFEMErrorCode build_finite_elements(int verb=DEFAULT_VERBOSITY)
Build finite elements.
Definition: FECore.cpp:655
convert.args
args
Definition: convert.py:66
MoFEM::FieldEntity::getLoLocalEntityBitNumber
static UId getLoLocalEntityBitNumber(const char bit_number, const EntityHandle ent)
Definition: FieldEntsMultiIndices.hpp:247
MoFEM::CoreTmp< 0 >::value
static constexpr int value
Definition: Core.hpp:84
CHK_THROW_MESSAGE
#define CHK_THROW_MESSAGE(err, msg)
Check and throw MoFEM exception.
Definition: definitions.h:609
L2
@ L2
field with C-1 continuity
Definition: definitions.h:88
MoFEM::CoreTmp< 0 >::wrapMPIMOABComm
boost::shared_ptr< WrapMPIComm > wrapMPIMOABComm
manage creation and destruction of MOAB communicator
Definition: Core.hpp:1029
MoFEM::CoreTmp< 0 >::th_ProblemNbDofsCol
Tag th_ProblemNbDofsCol
Definition: Core.hpp:265
MoFEM::CoreTmp< 0 >::th_ProblemGhostNbDofCol
Tag th_ProblemGhostNbDofCol
Definition: Core.hpp:267
MoFEM::CoreTmp< 0 >::loop_dofs
MoFEMErrorCode loop_dofs(const Problem *problem_ptr, const std::string &field_name, RowColData rc, DofMethod &method, int lower_rank, int upper_rank, int verb=DEFAULT_VERBOSITY)
Make a loop over dofs.
Definition: ProblemsCore.cpp:531
help
static char help[]
Definition: activate_deactivate_dofs.cpp:13
MoFEM::Types::BitProblemId
std::bitset< BITPROBLEMID_SIZE > BitProblemId
Problem Id.
Definition: Types.hpp:44
mofem_error_handler
static PetscErrorCode mofem_error_handler(MPI_Comm comm, int line, const char *fun, const char *file, PetscErrorCode n, PetscErrorType p, const char *mess, void *ctx)
Definition: ErrorHandler.cpp:6
MoFEM::CoreTmp< 0 >::entsFiniteElements
EntFiniteElement_multiIndex entsFiniteElements
finite element entities
Definition: Core.hpp:308
MoFEM::CoreTmp< 0 >::buildMoFEM
int * buildMoFEM
keeps flags/semaphores for different stages
Definition: Core.hpp:1038
SET_BASIC_METHOD
#define SET_BASIC_METHOD(METHOD, PROBLEM_PTR)
Definition: ProblemsCore.cpp:348
LASTCONTINUITY
@ LASTCONTINUITY
Definition: definitions.h:102
MoFEM::CoreTmp< 0 >::list_problem
MoFEMErrorCode list_problem() const
list problems
Definition: ProblemsCore.cpp:129
VERY_NOISY
@ VERY_NOISY
Definition: definitions.h:225
MoFEM::Types::BitFieldId
std::bitset< BITFIELDID_SIZE > BitFieldId
Field Id.
Definition: Types.hpp:42
MoFEM::CoreTmp< 0 >::problem_basic_method_postProcess
MoFEMErrorCode problem_basic_method_postProcess(const Problem *problem_ptr, BasicMethod &method, int verb=DEFAULT_VERBOSITY)
Set data for BasicMethod.
Definition: ProblemsCore.cpp:395
MoFEM::CoreTmp< 0 >::refinedEntities
RefEntity_multiIndex refinedEntities
refined entities
Definition: Core.hpp:300
MOFEM_LOG_ATTRIBUTES
#define MOFEM_LOG_ATTRIBUTES(channel, bit)
Add attributes to channel.
Definition: LogManager.hpp:296
MoFEM::CoreTmp< 0 >::get_field_structure
const Field * get_field_structure(const std::string &name, enum MoFEMTypes bh=MF_EXIST) const
get field structure
Definition: FieldCore.cpp:65
MoFEM::CoreTmp< 0 >::remove_parents_by_ents
MoFEMErrorCode remove_parents_by_ents(const Range &ents, int verb=DEFAULT_VERBOSITY)
Remove parents from entities.
Definition: DeleteCore.cpp:477
MoFEM::CoreTmp< 0 >::th_ProblemId
Tag th_ProblemId
Definition: Core.hpp:264
MoFEM::interface_RefEntity< RefEntity >::getEnt
EntityHandle getEnt() const
Get the entity handle.
Definition: RefEntsMultiIndices.hpp:603
MoFEM::CoreTmp< 0 >::th_ProblemLocalNbDofRow
Tag th_ProblemLocalNbDofRow
Definition: Core.hpp:266
MoFEM::CoreTmp< 0 >::clear_finite_elements
MoFEMErrorCode clear_finite_elements(const Range &ents, int verb=DEFAULT_VERBOSITY)
Definition: DeleteCore.cpp:273
MoFEM::UnknownInterface::getFileVersion
static MoFEMErrorCode getFileVersion(moab::Interface &moab, Version &version)
Get database major version.
Definition: UnknownInterface.cpp:16
MoFEM::FieldEntity::interface_type_RefEntity
interface_RefEntity< RefEntity > interface_type_RefEntity
Definition: FieldEntsMultiIndices.hpp:27
MOFEM_SUCCESS
@ MOFEM_SUCCESS
Definition: definitions.h:30
MoFEM::CoreTmp< 0 >::loop_entities
MoFEMErrorCode loop_entities(const Problem *problem_ptr, const std::string field_name, RowColData rc, EntityMethod &method, int lower_rank, int upper_rank, int verb=DEFAULT_VERBOSITY)
Loop over field entities in the problem.
Definition: ProblemsCore.cpp:650
DeleteCoreFunctionBegin
#define DeleteCoreFunctionBegin
Definition: DeleteCore.cpp:21
MoFEM::CoreTmp< 0 >::BUILD_ADJ
@ BUILD_ADJ
Definition: Core.hpp:214
MoFEM::CoreTmp< 0 >::th_FieldName_DataNamePrefix
Tag th_FieldName_DataNamePrefix
Definition: Core.hpp:260
MoFEM::CoreTmp< 0 >::Finalize
static MoFEMErrorCode Finalize()
Checks for options to be called at the conclusion of the program.
Definition: Core.cpp:112
MoFEM::CoreTmp< 0 >::clearMap
MoFEMErrorCode clearMap()
Cleaning database.
Definition: Core.cpp:503
MoFEM::no_handle
const EntityHandle no_handle
No entity handle is indicated by zero handle, i.e. root meshset.
Definition: Common.hpp:12
MoFEM::CoreTmp< 0 >::entFEAdjacencies
FieldEntityEntFiniteElementAdjacencyMap_multiIndex entFEAdjacencies
adjacencies of elements to dofs
Definition: Core.hpp:311
MoFEM::CoreTmp< 0 >::th_ProblemName
Tag th_ProblemName
Definition: Core.hpp:264
DATA
@ DATA
Definition: definitions.h:136
MoFEM::CoreTmp< 0 >::th_FEName
Tag th_FEName
Definition: Core.hpp:262
MoFEM::CoreTmp< 0 >::makeSharedRefEntity
static boost::shared_ptr< RefEntityTmp< 0 > > makeSharedRefEntity(MoFEM::Interface &m_field, const EntityHandle ent)
Definition: Core.cpp:928
MOFEM_IMPOSSIBLE_CASE
@ MOFEM_IMPOSSIBLE_CASE
Definition: definitions.h:35
MoFEM::Types::BitFEId
std::bitset< BITFEID_SIZE > BitFEId
Finite element Id.
Definition: Types.hpp:43
THROW_MESSAGE
#define THROW_MESSAGE(msg)
Throw MoFEM exception.
Definition: definitions.h:574
MoFEM::CoreTmp< 0 >::th_ProblemGhostNbDofRow
Tag th_ProblemGhostNbDofRow
Definition: Core.hpp:266
MoFEM::CoreTmp< 0 >::list_finite_elements
MoFEMErrorCode list_finite_elements() const
list finite elements in database
Definition: FECore.cpp:320
sdf.r
int r
Definition: sdf.py:8
USER_BASE
@ USER_BASE
user implemented approximation base
Definition: definitions.h:68
order
constexpr int order
Definition: dg_projection.cpp:18
MoFEM::LogManager::logPetscFPrintf
static PetscErrorCode logPetscFPrintf(FILE *fd, const char format[], va_list Argp)
Use to handle PETSc output.
Definition: LogManager.cpp:411
MoFEM::CoreTmp< 0 >::get_moab
moab::Interface & get_moab()
Definition: Core.hpp:322
ROW
@ ROW
Definition: definitions.h:136
MoFEM::CoreTmp< 0 >::addProblem
MoFEMErrorCode addProblem(const BitProblemId id, const std::string &name, int verb=DEFAULT_VERBOSITY)
add problem
Definition: ProblemsCore.cpp:27
MoFEM::Interface
DeprecatedCoreInterface Interface
Definition: Interface.hpp:2002
MoFEM::BitRefManager::fixTagSize
static MoFEMErrorCode fixTagSize(moab::Interface &moab, bool *changed=nullptr)
Fix tag size when BITREFLEVEL_SIZE of core library is different than file BITREFLEVEL_SIZE.
Definition: BitRefManager.cpp:1232
MoFEM::CoreTmp< 0 >::buildFieldForNoField
MoFEMErrorCode buildFieldForNoField(const BitFieldId id, std::map< EntityType, int > &dof_counter, int verb=DEFAULT_VERBOSITY)
Definition: FieldCore.cpp:1097
MOFEM_LOG_FUNCTION
#define MOFEM_LOG_FUNCTION()
Set scope.
Definition: LogManager.hpp:325
MoFEM::CoreTmp< 0 >::clear_ents_fields
MoFEMErrorCode clear_ents_fields(const Range ents, int verb=DEFAULT_VERBOSITY)
Definition: DeleteCore.cpp:113
MoFEM::CoreTmp< 0 >::get_fe_by_name_end
EntFiniteElement_multiIndex::index< Unique_mi_tag >::type::iterator get_fe_by_name_end(const std::string &fe_name) const
get end iterator of finite elements of given name (instead you can use IT_GET_FES_BY_NAME_FOR_LOOP(MF...
Definition: FECore.cpp:847
MoFEM::CoreTmp< 0 >::clear_adjacencies_entities
MoFEMErrorCode clear_adjacencies_entities(const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
clear adjacency map for entities on given bit level
Definition: DeleteCore.cpp:201
MoFEM::CoreTmp< 0 >::pRoblems
Problem_multiIndex pRoblems
problems multi-index
Definition: Core.hpp:313
MoFEM::CoreTmp< 0 >::MOFEM_EVENT_preProcess
PetscLogEvent MOFEM_EVENT_preProcess
Event for preProcess finite element.
Definition: Core.hpp:991
FieldSpace
FieldSpace
approximation spaces
Definition: definitions.h:82
MoFEM::LogManager::BitLineID
@ BitLineID
Definition: LogManager.hpp:48
MoFEM::LogManager::BitScope
@ BitScope
Definition: LogManager.hpp:49
MoFEM::Exceptions::rval
static MoFEMErrorCodeGeneric< moab::ErrorCode > rval
Definition: Exceptions.hpp:74
VERBOSE
@ VERBOSE
Definition: definitions.h:222
MoFEM::CoreTmp< 0 >::addField
MoFEMErrorCode addField(const std::string &name, const FieldSpace space, const FieldContinuity continuity, const FieldApproximationBase base, const FieldCoefficientsNumber nb_coefficients, const TagType tag_type, const enum MoFEMTypes bh, int verb)
Template for add_field.
Definition: FieldCore.cpp:108
CHKERR
#define CHKERR
Inline error check.
Definition: definitions.h:548
MoFEM::CoreTmp< 0 >::th_RefParentHandle
Tag th_RefParentHandle
Definition: Core.hpp:258
MoFEM::CoreTmp< 0 >::get_field_meshset
EntityHandle get_field_meshset(const BitFieldId id) const
Definition: FieldCore.cpp:45
MoFEM::CoreTmp< 0 >::get_comm_size
int get_comm_size() const
Definition: Core.hpp:1018
MoFEM::CoreTmp< 0 >::MOFEM_EVENT_createMat
PetscLogEvent MOFEM_EVENT_createMat
Definition: Core.hpp:996
MoFEM::CoreTmp< 0 >::addEntsToFieldByDim
MoFEMErrorCode addEntsToFieldByDim(const Range &ents, const int dim, const std::string &name, int verb=DEFAULT_VERBOSITY)
Definition: FieldCore.cpp:300
MoFEM::CoreTmp< 0 >::get_field_bit_number
FieldBitNumber get_field_bit_number(const std::string name) const
get field bit number
Definition: FieldCore.cpp:28
a
constexpr double a
Definition: approx_sphere.cpp:30
MoFEM::CoreTmp< 0 >::iFaces
boost::ptr_map< boost::typeindex::type_index, UnknownInterface > iFaces
Hash map of pointers to interfaces.
Definition: Core.hpp:1036
MoFEM::CoreTmp< 0 >::th_FieldBase
Tag th_FieldBase
Definition: Core.hpp:261
FieldContinuity
FieldContinuity
Field continuity.
Definition: definitions.h:99
MOFEM_LOG_C
#define MOFEM_LOG_C(channel, severity, format,...)
Definition: LogManager.hpp:311
MoFEM::Types::UId
uint128_t UId
Unique Id.
Definition: Types.hpp:31
MoFEM::CoreTmp< 0 >::mpiInitialised
static int mpiInitialised
mpi was initialised by other agent
Definition: Core.hpp:1049
MoFEM::CoreTmp< 0 >::list_fields
MoFEMErrorCode list_fields() const
list entities in the field
Definition: FieldCore.cpp:1326
MoFEM::FieldEntity::makeSharedFieldDataAdaptorPtr
static boost::shared_ptr< FieldData *const > makeSharedFieldDataAdaptorPtr(const boost::shared_ptr< Field > &field_ptr, const boost::shared_ptr< RefEntity > &ref_ents_ptr)
Return shared pointer to entity field data vector adaptor.
Definition: FieldEntsMultiIndices.cpp:35
bit
auto bit
set bit
Definition: hanging_node_approx.cpp:75
MoFEM::CoreTmp< 0 >::th_FEIdRow
Tag th_FEIdRow
Definition: Core.hpp:263
MoFEM::CoreTmp< 0 >::refinedFiniteElements
RefElement_multiIndex refinedFiniteElements
refined elements
Definition: Core.hpp:301
MoFEM::Types::FieldCoefficientsNumber
int FieldCoefficientsNumber
Number of field coefficients.
Definition: Types.hpp:27
convert.type
type
Definition: convert.py:64
MoFEM::CoreTmp< 0 >::th_FieldSpace
Tag th_FieldSpace
Definition: Core.hpp:260
MoFEM::FieldEntity::getLocalUniqueIdCalculate
UId getLocalUniqueIdCalculate()
Get the Local Unique Id Calculate object.
Definition: FieldEntsMultiIndices.hpp:136
MoFEM::CoreInterface::get_basic_entity_data_ptr
virtual boost::shared_ptr< BasicEntityData > & get_basic_entity_data_ptr()=0
Get pointer to basic entity data.
MoFEM::EntFiniteElement::getLocalUniqueIdCalculate
UId getLocalUniqueIdCalculate() const
Generate UId for finite element entity.
Definition: FEMultiIndices.hpp:528
MoFEM::CoreTmp< 0 >::BUILD_FIELD
@ BUILD_FIELD
Definition: Core.hpp:212
MOFEM_LOG_SYNCHRONISE
#define MOFEM_LOG_SYNCHRONISE(comm)
Synchronise "SYNC" channel.
Definition: LogManager.hpp:345
MoFEM::CoreTmp< 0 >::th_ProblemFEId
Tag th_ProblemFEId
Definition: Core.hpp:264
MoFEM::FieldEntity::getLoBitNumberUId
static UId getLoBitNumberUId(const FieldBitNumber bit_number)
Definition: FieldEntsMultiIndices.hpp:222
MoFEM::CoreTmp< 0 >::isGloballyInitialised
static bool isGloballyInitialised
Core base globally initialized.
Definition: Core.hpp:1048
COL
@ COL
Definition: definitions.h:136
MoFEM::CoreTmp< 0 >::sIze
int sIze
MoFEM communicator size.
Definition: Core.hpp:1007
MoFEM::CoreTmp< 0 >::initaliseAndBuildField
PetscBool initaliseAndBuildField
Definition: Core.hpp:1042
MoFEM::CoreTmp< 0 >::th_RefBitLevel_Mask
Tag th_RefBitLevel_Mask
Definition: Core.hpp:258
LASTSPACE
@ LASTSPACE
FieldSpace in [ 0, LASTSPACE )
Definition: definitions.h:89
MoFEM::get_id_for_max_type
EntityHandle get_id_for_max_type()
Definition: RefEntsMultiIndices.hpp:13
ProblemCoreFunctionBegin
#define ProblemCoreFunctionBegin
Definition: ProblemsCore.cpp:8
MoFEM::CoreTmp< 0 >::BUILD_PROBLEM
@ BUILD_PROBLEM
Definition: Core.hpp:215
MoFEM::CoreTmp< 0 >::add_ents_to_finite_element_by_bit_ref
MoFEMErrorCode add_ents_to_finite_element_by_bit_ref(const BitRefLevel &bit, const BitRefLevel &mask, const std::string &name, EntityType type, int verb=DEFAULT_VERBOSITY)
add TET entities from given refinement level to finite element database given by name
Definition: FECore.cpp:405
MoFEM::CoreTmp< 0 >::clear_adjacencies_finite_elements
MoFEMErrorCode clear_adjacencies_finite_elements(const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)
clear adjacency map for finite elements on given bit level
Definition: DeleteCore.cpp:312
MoFEM::CoreTmp< 0 >::isInitialized
static PetscBool isInitialized
petsc was initialised by other agent
Definition: Core.hpp:1050
MoFEM::LogManager::getOptions
static MoFEMErrorCode getOptions()
Get logger option.
Definition: LogManager.cpp:152
MoFEM::CoreTmp< 0 >::buildFieldForL2H1HcurlHdiv
MoFEMErrorCode buildFieldForL2H1HcurlHdiv(const BitFieldId id, std::map< EntityType, int > &dof_counter, std::map< EntityType, int > &inactive_dof_counter, int verb=DEFAULT_VERBOSITY)
Definition: FieldCore.cpp:1120
MoFEM::CoreTmp< 0 >::buildField
MoFEMErrorCode buildField(const boost::shared_ptr< Field > &field, int verb=DEFAULT_VERBOSITY)
Definition: FieldCore.cpp:1232
MoFEM::CoreTmp< 0 >::PARTITION_PROBLEM
@ PARTITION_PROBLEM
Definition: Core.hpp:216
MOFEM_OPERATION_UNSUCCESSFUL
@ MOFEM_OPERATION_UNSUCCESSFUL
Definition: definitions.h:34
MoFEM::type_from_handle
auto type_from_handle(const EntityHandle h)
get type from entity handle
Definition: Templates.hpp:1876
MB_ID_WIDTH
#define MB_ID_WIDTH
Definition: definitions.h:240
MoFEM::CoreTmp< 0 >::initaliseAndBuildFiniteElements
PetscBool initaliseAndBuildFiniteElements
Definition: Core.hpp:1045
BYDATA
@ BYDATA
Definition: definitions.h:146
MOFEM_LOG_TAG
#define MOFEM_LOG_TAG(channel, tag)
Tag channel.
Definition: LogManager.hpp:339
MoFEM::CoreTmp< 0 >::th_FieldName
Tag th_FieldName
Definition: Core.hpp:260
MoFEM::CacheTupleSharedPtr
boost::shared_ptr< CacheTuple > CacheTupleSharedPtr
Definition: FEMultiIndices.hpp:495
MoFEM::CoreTmp< 0 >::finiteElements
FiniteElement_multiIndex finiteElements
finite elements
Definition: Core.hpp:307
MoFEM::CoreTmp< 0 >::th_FieldId
Tag th_FieldId
Definition: Core.hpp:260
i
FTensor::Index< 'i', SPACE_DIM > i
Definition: hcurl_divergence_operator_2d.cpp:27
MoFEM::CoreTmp< 0 >::th_ProblemNbDofsRow
Tag th_ProblemNbDofsRow
Definition: Core.hpp:265
MoFEM::DofEntity::getLoFieldEntityUId
static UId getLoFieldEntityUId(const FieldBitNumber bit, const EntityHandle ent)
Definition: DofsMultiIndices.hpp:69
MoFEM::CoreTmp< 0 >::th_Part
Tag th_Part
Tag for partition number.
Definition: Core.hpp:257
MoFEM::CoreTmp< 0 >::buildFiniteElements
MoFEMErrorCode buildFiniteElements(const boost::shared_ptr< FiniteElement > &fe, const Range *ents_ptr=NULL, int verb=DEFAULT_VERBOSITY)
Definition: FECore.cpp:459
MoFEM::CoreTmp< 0 >::moab
std::reference_wrapper< moab::Interface > moab
moab database
Definition: Core.hpp:321
MOFEM_NOT_FOUND
@ MOFEM_NOT_FOUND
Definition: definitions.h:33
main
int main(int argc, char *argv[])
Definition: activate_deactivate_dofs.cpp:15
MoFEM::CoreTmp< 0 >::loop_finite_elements
MoFEMErrorCode loop_finite_elements(const Problem *problem_ptr, const std::string &fe_name, FEMethod &method, int lower_rank, int upper_rank, boost::shared_ptr< NumeredEntFiniteElement_multiIndex > fe_ptr=nullptr, MoFEMTypes bh=MF_EXIST, CacheTupleWeakPtr cache_ptr=CacheTupleSharedPtr(), int verb=DEFAULT_VERBOSITY)
Make a loop over finite elements on partitions from upper to lower rank.
Definition: ProblemsCore.cpp:427
MoFEM::CoreTmp< 0 >::get_basic_entity_data_ptr
boost::shared_ptr< BasicEntityData > & get_basic_entity_data_ptr()
Get pointer to basic entity data.
Definition: Core.hpp:290
MoFEM::CoreTmp< 0 >::mofemComm
MPI_Comm mofemComm
MoFEM communicator.
Definition: Core.hpp:1004
field_name
constexpr auto field_name
Definition: poisson_2d_homogeneous.cpp:13
MoFEM::CoreTmp< 0 >::th_RefBitEdge
Tag th_RefBitEdge
Definition: Core.hpp:258
FECoreFunctionBegin
#define FECoreFunctionBegin
Definition: FECore.cpp:7
MoFEM::CoreTmp< 0 >::CoreTmp
CoreTmp(moab::Interface &moab, MPI_Comm comm=PETSC_COMM_WORLD, const int verbose=VERBOSE)
Definition: Core.cpp:235
convert.n
n
Definition: convert.py:82
MoFEM::CoreTmp< 0 >::pComm
ParallelComm * pComm
MOAB communicator structure.
Definition: Core.hpp:1005
MoFEM::CoreTmp< 0 >::buildFieldForNoFieldImpl
MoFEMErrorCode buildFieldForNoFieldImpl(boost::shared_ptr< Field > field_ptr, std::map< EntityType, int > &dof_counter, int verb)
Definition: FieldCore.cpp:992
MAX_DOFS_ON_ENTITY
#define MAX_DOFS_ON_ENTITY
Maximal number of DOFs on entity.
Definition: definitions.h:249
MoFEM::CoreTmp< 0 >::problem_basic_method_preProcess
MoFEMErrorCode problem_basic_method_preProcess(const Problem *problem_ptr, BasicMethod &method, int verb=DEFAULT_VERBOSITY)
Set data for BasicMethod.
Definition: ProblemsCore.cpp:363
MoFEM::CoreTmp< 0 >::verbose
int verbose
Verbosity level.
Definition: Core.hpp:1031
MoFEM::set_ref_ent_basic_data_ptr_impl
void set_ref_ent_basic_data_ptr_impl(boost::shared_ptr< BasicEntityData > &ptr)
Definition: Core.cpp:900
v
const double v
phase velocity of light in medium (cm/ns)
Definition: initial_diffusion.cpp:40
MoFEM::CoreTmp< 0 >::PARTITION_FE
@ PARTITION_FE
Definition: Core.hpp:217
Range
MoFEM::CoreTmp< 0 >::Initialize
static MoFEMErrorCode Initialize(int *argc, char ***args, const char file[], const char help[])
Initializes the MoFEM database PETSc, MOAB and MPI.
Definition: Core.cpp:72
FTensor::dd
const Tensor2_symmetric_Expr< const ddTensor0< T, Dim, i, j >, typename promote< T, double >::V, Dim, i, j > dd(const Tensor0< T * > &a, const Index< i, Dim > index1, const Index< j, Dim > index2, const Tensor1< int, Dim > &d_ijk, const Tensor1< double, Dim > &d_xyz)
Definition: ddTensor0.hpp:33
MOFEM_LOG
#define MOFEM_LOG(channel, severity)
Log.
Definition: LogManager.hpp:308
BYCOL
@ BYCOL
Definition: definitions.h:145
MoFEM::Types::ApproximationOrder
int ApproximationOrder
Approximation on the entity.
Definition: Types.hpp:26
CATCH_ERRORS
#define CATCH_ERRORS
Catch errors.
Definition: definitions.h:385
MoFEM::CoreTmp< 0 >::get_problem
MoFEMErrorCode get_problem(const std::string &problem_name, const Problem **problem_ptr) const
Get problem database (data structure)
Definition: Core.cpp:801
MoFEM::CoreTmp< 0 >::th_FieldContinuity
Tag th_FieldContinuity
Definition: Core.hpp:261
MoFEM::DofEntity::getHiFieldEntityUId
static UId getHiFieldEntityUId(const FieldBitNumber bit, const EntityHandle ent)
Definition: DofsMultiIndices.hpp:75
MoFEM::CoreTmp< 0 >::optionsPrefix
std::string optionsPrefix
Prefix for options on command line.
Definition: Core.hpp:1040
MoFEM::CoreTmp< 0 >::fIelds
Field_multiIndex fIelds
fields
Definition: Core.hpp:303
MoFEM::CoreTmp< 0 >::PARTITION_MESH
@ PARTITION_MESH
Definition: Core.hpp:219
MoFEM::Core
CoreTmp< 0 > Core
Definition: Core.hpp:1140
MoFEM::CoreTmp< 0 >::getTags
MoFEMErrorCode getTags(int verb=DEFAULT_VERBOSITY)
Get tag handles.
Definition: Core.cpp:551
HenckyOps::f
auto f
Definition: HenckyOps.hpp:15
MoFEM::Types::BitRefEdges
std::bitset< BITREFEDGES_SIZE > BitRefEdges
Definition: Types.hpp:34
MoFEM::CoreTmp< 0 >::set_field_order
MoFEMErrorCode set_field_order(const Range &ents, const BitFieldId id, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)
Definition: FieldCore.cpp:906
DISCONTINUOUS
@ DISCONTINUOUS
Broken continuity (No effect on L2 space)
Definition: definitions.h:101
MoFEM::Exceptions::ierr
static MoFEMErrorCodeGeneric< PetscErrorCode > ierr
Definition: Exceptions.hpp:76
MoFEM::CoreTmp< 0 >::remove_ents_from_finite_element
MoFEMErrorCode remove_ents_from_finite_element(const std::string name, const EntityHandle meshset, const EntityType type, int verb=DEFAULT_VERBOSITY)
remove entities from given refinement level to finite element database
Definition: DeleteCore.cpp:379
MoFEM::MPC::LAST
@ LAST
MoFEM::Types::FieldData
double FieldData
Field data type.
Definition: Types.hpp:25
HCURL
@ HCURL
field with continuous tangents
Definition: definitions.h:86
MOFEM_DATA_INCONSISTENCY
@ MOFEM_DATA_INCONSISTENCY
Definition: definitions.h:31
MoFEM::CoreTmp< 0 >::coreGenericConstructor
MoFEMErrorCode coreGenericConstructor(moab::Interface &moab, MPI_Comm comm, const int verbose)
Definition: Core.cpp:197
MoFEM::CoreTmp< 0 >::th_ProblemLocalNbDofCol
Tag th_ProblemLocalNbDofCol
Definition: Core.hpp:267
MoFEM::LogManager::createDefaultSinks
static void createDefaultSinks(MPI_Comm comm)
Create default sinks.
Definition: LogManager.cpp:313
FieldCoreFunctionBegin
#define FieldCoreFunctionBegin
Definition: FieldCore.cpp:8
sdf_hertz_2d_axisymm_plane.d
float d
Definition: sdf_hertz_2d_axisymm_plane.py:4
FieldApproximationBase
FieldApproximationBase
approximation base
Definition: definitions.h:58
MoFEM::FieldEntity::getHiBitNumberUId
static UId getHiBitNumberUId(const FieldBitNumber bit_number)
Definition: FieldEntsMultiIndices.hpp:228
MoFEM::Types::VectorDouble
UBlasVector< double > VectorDouble
Definition: Types.hpp:68
MoFEM::interface_RefEntity< RefEntity >::interface_RefEntity
interface_RefEntity(const boost::shared_ptr< RefEntity > &sptr)
Definition: RefEntsMultiIndices.hpp:574
MoFEM::FieldEntity::getHiLocalEntityBitNumber
static UId getHiLocalEntityBitNumber(const char bit_number, const EntityHandle ent)
Definition: FieldEntsMultiIndices.hpp:258
MoFEM::CoreTmp< 0 >::BUILD_FE
@ BUILD_FE
Definition: Core.hpp:213
m
FTensor::Index< 'm', 3 > m
Definition: shallow_wave.cpp:80
MoFEM::CoreTmp< 0 >::th_FEIdCol
Tag th_FEIdCol
Definition: Core.hpp:263
BYROW
@ BYROW
Definition: definitions.h:144
MoFEM::CoreTmp< 0 >::get_finite_element_meshset
EntityHandle get_finite_element_meshset(const BitFEId id) const
Definition: FECore.cpp:273
MoFEM::CoreTmp< 0 >::dofsField
DofEntity_multiIndex dofsField
dofs on fields
Definition: Core.hpp:305
MoFEM::CoreTmp< 0 >::clear_dofs_fields
MoFEMErrorCode clear_dofs_fields(const Range ents, int verb=DEFAULT_VERBOSITY)
Definition: DeleteCore.cpp:57
MoFEM::Types::BitRefLevel
std::bitset< BITREFLEVEL_SIZE > BitRefLevel
Bit structure attached to each entity identifying to what mesh entity is attached.
Definition: Types.hpp:40
MoFEM::CoreTmp< 0 >::get_field_id
BitFieldId get_field_id(const std::string &name) const
Get field Id.
Definition: FieldCore.cpp:18
MoFEMFunctionBeginHot
#define MoFEMFunctionBeginHot
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
Definition: definitions.h:453
QUIET
@ QUIET
Definition: definitions.h:221
MoFEM::CoreTmp< 0 >::cache_problem_entities
MoFEMErrorCode cache_problem_entities(const std::string prb_name, CacheTupleWeakPtr cache_ptr)
Cache variables.
Definition: ProblemsCore.cpp:798
MoFEM::field_it
Field_multiIndex::index< FieldName_mi_tag >::type::iterator field_it
Definition: Projection10NodeCoordsOnField.cpp:123
MoFEM::CoreTmp< 0 >::clear_problem
MoFEMErrorCode clear_problem(const std::string name, int verb=DEFAULT_VERBOSITY)
clear problem
Definition: ProblemsCore.cpp:269
MoFEM::CoreInterface
Interface.
Definition: Interface.hpp:27
MoFEM::CoreTmp< 0 >::entsFields
FieldEntity_multiIndex entsFields
entities on fields
Definition: Core.hpp:304
MoFEM::CoreTmp< 0 >::PARTITION_GHOST_DOFS
@ PARTITION_GHOST_DOFS
Definition: Core.hpp:218
MF_NOT_THROW
@ MF_NOT_THROW
Definition: definitions.h:114
MoFEM::CoreTmp< 0 >::getBitFEId
BitFEId getBitFEId(const std::string &fe_name) const
Get field Id.
Definition: FECore.cpp:255
MoFEM::CoreTmp< 0 >::check_finite_element
bool check_finite_element(const std::string &name) const
Check if finite element is in database.
Definition: FECore.cpp:35
MF_EXCL
@ MF_EXCL
Definition: definitions.h:112
CONTINUOUS
@ CONTINUOUS
Regular field.
Definition: definitions.h:100
MoFEM::CoreTmp< 0 >::get_fe_by_name_begin
EntFiniteElement_multiIndex::index< Unique_mi_tag >::type::iterator get_fe_by_name_begin(const std::string &fe_name) const
get begin iterator of finite elements of given name (instead you can use IT_GET_FES_BY_NAME_FOR_LOOP(...
Definition: FECore.cpp:836
MoFEM::CoreTmp< 0 >::setRefEntBasicDataPtr
static void setRefEntBasicDataPtr(MoFEM::Interface &m_field, boost::shared_ptr< BasicEntityData > &ptr)
Definition: Core.cpp:909
MoFEM::get_id_for_min_type
EntityHandle get_id_for_min_type()
Definition: RefEntsMultiIndices.hpp:18
MoFEM::CoreTmp< 0 >::th_MoFEMBuild
Tag th_MoFEMBuild
Definition: Core.hpp:270
MF_EXIST
@ MF_EXIST
Definition: definitions.h:113
MoFEMFunctionReturn
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
Definition: definitions.h:429
MoFEM::CoreTmp< 0 >::remove_ents
MoFEMErrorCode remove_ents(const Range ents, int verb=DEFAULT_VERBOSITY)
remove entities form mofem database
Definition: DeleteCore.cpp:429
HDIV
@ HDIV
field with continuous normal traction
Definition: definitions.h:87
MOFEM_NOT_IMPLEMENTED
@ MOFEM_NOT_IMPLEMENTED
Definition: definitions.h:32
MoFEM::get_sub_iface_options_imp
static auto get_sub_iface_options_imp(T *const ptr, int) -> decltype(ptr->getSubInterfaceOptions())
Definition: Core.cpp:138
MoFEM::CoreTmp< 0 >::build_adjacencies
MoFEMErrorCode build_adjacencies(const Range &ents, int verb=DEFAULT_VERBOSITY)
build adjacencies
Definition: FECore.cpp:742
CHKERRG
#define CHKERRG(n)
Check error code of MoFEM/MOAB/PETSc function.
Definition: definitions.h:496
MoFEM::CoreTmp< 0 >::MOFEM_EVENT_postProcess
PetscLogEvent MOFEM_EVENT_postProcess
Event for postProcess finite element.
Definition: Core.hpp:995
MoFEM::CoreTmp< 0 >::th_FEId
Tag th_FEId
Definition: Core.hpp:262
MoFEM::CoreTmp< 0 >::basicEntityDataPtr
boost::shared_ptr< BasicEntityData > basicEntityDataPtr
Definition: Core.hpp:281
MoFEMFunctionBegin
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
Definition: definitions.h:359
MOFEM_INVALID_DATA
@ MOFEM_INVALID_DATA
Definition: definitions.h:36
MoFEM::CoreInterface::getValue
virtual const int getValue() const =0
Get the core.
MoFEM::CoreTmp< 0 >::initialiseDatabaseFromMesh
MoFEMErrorCode initialiseDatabaseFromMesh(int verb=DEFAULT_VERBOSITY)
Initialize database getting information on mesh.
Definition: Core.cpp:294
MoFEM::CoreTmp< 0 >::th_RefBitLevel
Tag th_RefBitLevel
Definition: Core.hpp:258
MoFEM::get_event_options_imp
static auto get_event_options_imp(T *const ptr, int) -> decltype(ptr->getEventOptions())
Definition: Core.cpp:151
MoFEM::CoreTmp< 0 >::getValue
const int getValue() const
Get the core.
Definition: Core.hpp:85
MoFEM::UnknownInterface::getInterface
IFACE getInterface() const
Get interface pointer to pointer of interface.
Definition: UnknownInterface.hpp:162
NOFIELD
@ NOFIELD
scalar or vector of scalars describe (no true field)
Definition: definitions.h:84
MoFEM::CoreTmp< 0 >::remove_ents_from_field
MoFEMErrorCode remove_ents_from_field(const std::string name, const EntityHandle meshset, const EntityType type, int verb=DEFAULT_VERBOSITY)
remove entities from field
Definition: DeleteCore.cpp:152
MoFEM::Types::DofIdx
int DofIdx
Index of DOF.
Definition: Types.hpp:18