v0.15.0
Loading...
Searching...
No Matches
MoFEM::DeprecatedCoreInterface Struct Reference

Deprecated interface functions. More...

#include "src/interfaces/DeprecatedCoreInterface.hpp"

Inheritance diagram for MoFEM::DeprecatedCoreInterface:
[legend]
Collaboration diagram for MoFEM::DeprecatedCoreInterface:
[legend]

Seed entities

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
 
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
 
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
 
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.
 

Synchronize

DEPRECATED MoFEMErrorCode synchronise_entities (Range &ent, int verb=DEFAULT_VERBOSITY)
 
DEPRECATED MoFEMErrorCode synchronise_field_entities (const std::string &name, int verb=DEFAULT_VERBOSITY)
 

Additional Inherited Members

- Public Member Functions inherited from MoFEM::CoreInterface
virtual ~CoreInterface ()=default
 
virtual const int getValue () const =0
 Get the core.
 
virtual boost::shared_ptr< RefEntityTmp< 0 > > make_shared_ref_entity (const EntityHandle ent)=0
 Get RefEntity.
 
virtual moab::Interface & get_moab ()=0
 
virtual const moab::Interface & get_moab () const =0
 
virtual MoFEMErrorCode set_moab_interface (moab::Interface &new_moab, int verb=VERBOSE)=0
 Set the moab interface object.
 
virtual MeshsetsManagerget_meshsets_manager_ptr ()=0
 get MeshsetsManager pointer
 
virtual const MeshsetsManagerget_meshsets_manager_ptr () const =0
 get MeshsetsManager pointer
 
virtual MeshsetsManagerget_meshsets_manager ()=0
 get MeshsetsManager pointer
 
virtual const MeshsetsManagerget_meshsets_manager () const =0
 get MeshsetsManager pointer
 
virtual boost::shared_ptr< BasicEntityData > & get_basic_entity_data_ptr ()=0
 Get pointer to basic entity data.
 
virtual MPI_Comm & get_comm () const =0
 
virtual int get_comm_size () const =0
 
virtual int get_comm_rank () const =0
 
virtual MoFEMErrorCode check_number_of_ents_in_ents_field (const std::string &name) const =0
 check data consistency in entitiesPtr
 
virtual MoFEMErrorCode check_number_of_ents_in_ents_field () const =0
 check data consistency in entitiesPtr
 
virtual MoFEMErrorCode check_number_of_ents_in_ents_finite_element (const std::string &name) const =0
 check data consistency in entsFiniteElements
 
virtual MoFEMErrorCode check_number_of_ents_in_ents_finite_element () const =0
 check data consistency in entsFiniteElements
 
virtual MoFEMErrorCode clear_database (int verb=DEFAULT_VERBOSITY)=0
 Clear database.
 
virtual MoFEMErrorCode rebuild_database (int verb=DEFAULT_VERBOSITY)=0
 Clear database and initialize it once again.
 
virtual MoFEMErrorCode remove_parents_by_ents (const Range &ents, int verb=DEFAULT_VERBOSITY)=0
 Remove parents from entities.
 
virtual MoFEMErrorCode remove_parents_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 Remove parent from entities on bit level.
 
virtual MoFEMErrorCode remove_parents_by_parents (const Range &ents, int verb=DEFAULT_VERBOSITY)=0
 Remove paremts from entities having parents in passed range.
 
virtual 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)=0
 delete entities form mofem and moab database
 
virtual MoFEMErrorCode remove_ents (const Range ents, int verb=DEFAULT_VERBOSITY)=0
 remove entities form mofem database
 
virtual MoFEMErrorCode remove_ents_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 remove entities form mofem database
 
virtual MoFEMErrorCode delete_finite_element (const std::string name, int verb=DEFAULT_VERBOSITY)=0
 delete finite element from mofem database
 
virtual MoFEMErrorCode add_broken_field (const std::string name, const FieldSpace space, const FieldApproximationBase base, const FieldCoefficientsNumber nb_of_coefficients, const std::vector< std::pair< EntityType, std::function< MoFEMErrorCode(BaseFunction::DofsSideMap &)> > > list_dof_side_map, const TagType tag_type=MB_TAG_SPARSE, const enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)=0
 Add field.
 
virtual MoFEMErrorCode add_field (const std::string name, const FieldSpace space, const FieldApproximationBase base, const FieldCoefficientsNumber nb_of_coefficients, const TagType tag_type=MB_TAG_SPARSE, const enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)=0
 Add field.
 
virtual MoFEMErrorCode delete_field (const std::string name, int verb=DEFAULT_VERBOSITY)=0
 Delete field.
 
virtual MoFEMErrorCode add_ents_to_field_by_dim (const Range &ents, const int dim, const std::string &name, int verb=DEFAULT_VERBOSITY)=0
 Add entities to field meshset.
 
virtual MoFEMErrorCode add_ents_to_field_by_type (const Range &ents, const EntityType type, const std::string &name, int verb=DEFAULT_VERBOSITY)=0
 Add entities to field meshset.
 
virtual 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)=0
 Add entities to field meshset.
 
virtual 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)=0
 Add entities to field meshset.
 
virtual MoFEMErrorCode create_vertices_and_add_to_field (const std::string name, const double coords[], int size, int verb=DEFAULT_VERBOSITY)=0
 Create a vertices and add to field object.
 
virtual MoFEMErrorCode remove_ents_from_field_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 remove entities from field
 
virtual MoFEMErrorCode remove_ents_from_field (const std::string name, const EntityHandle meshset, const EntityType type, int verb=DEFAULT_VERBOSITY)=0
 remove entities from field
 
virtual MoFEMErrorCode remove_ents_from_field (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)=0
 remove entities from field
 
virtual MoFEMErrorCode remove_ents_from_field (const Range ents, int verb=DEFAULT_VERBOSITY)=0
 remove entities from all fields
 
virtual MoFEMErrorCode set_field_order (const EntityHandle meshset, const EntityType type, const std::string &name, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)=0
 Set order approximation of the entities in the field.
 
virtual MoFEMErrorCode set_field_order (const Range &ents, const std::string &name, const ApproximationOrder order, int verb=DEFAULT_VERBOSITY)=0
 Set order approximation of the entities in the field.
 
virtual 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)=0
 Set order approximation of the entities in the field.
 
virtual MoFEMErrorCode list_fields () const =0
 list entities in the field
 
virtual MoFEMErrorCode build_fields (int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode build_field (const std::string field_name, int verb=DEFAULT_VERBOSITY)=0
 build field by name
 
virtual BitFieldId get_field_id (const std::string &name) const =0
 Get field Id.
 
virtual FieldBitNumber get_field_bit_number (const std::string name) const =0
 get field bit number
 
virtual std::string get_field_name (const BitFieldId id) const =0
 get field name from id
 
virtual EntityHandle get_field_meshset (const std::string name) const =0
 get field meshset
 
virtual MoFEMErrorCode get_field_entities_by_dimension (const std::string name, int dim, Range &ents) const =0
 get entities in the field by dimension
 
virtual MoFEMErrorCode get_field_entities_by_type (const std::string name, EntityType type, Range &ents) const =0
 get entities in the field by type
 
virtual MoFEMErrorCode get_field_entities_by_handle (const std::string name, Range &ents) const =0
 get entities in the field by handle
 
virtual bool check_field (const std::string &name) const =0
 check if field is in database
 
virtual const Fieldget_field_structure (const std::string &name, enum MoFEMTypes bh=MF_EXIST) const =0
 get field structure
 
virtual const FiniteElementget_finite_element_structure (const std::string &name, enum MoFEMTypes bh=MF_EXIST) const =0
 get finite element struture
 
virtual bool check_finite_element (const std::string &name) const =0
 Check if finite element is in database.
 
virtual MoFEMErrorCode add_finite_element (const std::string &fe_name, enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)=0
 add finite element
 
virtual MoFEMErrorCode modify_finite_element_adjacency_table (const std::string &fe_name, const EntityType type, ElementAdjacencyFunct function)=0
 modify finite element table, only for advanced user
 
virtual MoFEMErrorCode modify_finite_element_add_field_data (const std::string &fe_name, const std::string name_field)=0
 set finite element field data
 
virtual MoFEMErrorCode modify_finite_element_off_field_data (const std::string &fe_name, const std::string name_field)=0
 unset finite element field data
 
virtual MoFEMErrorCode modify_finite_element_add_field_row (const std::string &fe_name, const std::string name_row)=0
 set field row which finite element use
 
virtual MoFEMErrorCode modify_finite_element_off_field_row (const std::string &fe_name, const std::string name_row)=0
 unset field row which finite element use
 
virtual MoFEMErrorCode modify_finite_element_add_field_col (const std::string &fe_name, const std::string name_row)=0
 set field col which finite element use
 
virtual MoFEMErrorCode modify_finite_element_off_field_col (const std::string &fe_name, const std::string name_row)=0
 unset field col which finite element use
 
virtual MoFEMErrorCode add_ents_to_finite_element_by_type (const EntityHandle entities, const EntityType type, const std::string name, const bool recursive=true)=0
 add entities to finite element
 
virtual MoFEMErrorCode add_ents_to_finite_element_by_dim (const EntityHandle entities, const int dim, const std::string name, const bool recursive=true)=0
 add entities to finite element
 
virtual MoFEMErrorCode add_ents_to_finite_element_by_type (const Range ents, const EntityType type, const std::string name)=0
 add entities to finite elements
 
virtual MoFEMErrorCode add_ents_to_finite_element_by_dim (const Range ents, const int dim, const std::string name)=0
 add entities to finite elements
 
virtual 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)=0
 add TET entities from given refinement level to finite element database given by name
 
virtual EntityHandle get_finite_element_meshset (const std::string name) const =0
 
virtual MoFEMErrorCode get_finite_element_entities_by_dimension (const std::string name, int dim, Range &ents) const =0
 get entities in the finite element by dimension
 
virtual MoFEMErrorCode get_finite_element_entities_by_type (const std::string name, EntityType type, Range &ents) const =0
 get entities in the finite element by type
 
virtual MoFEMErrorCode get_finite_element_entities_by_handle (const std::string name, Range &ents) const =0
 get entities in the finite element by handle
 
virtual MoFEMErrorCode remove_ents_from_finite_element_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 remove elements from given refinement level to finite element database
 
virtual MoFEMErrorCode remove_ents_from_finite_element (const std::string name, const EntityHandle meshset, const EntityType type, int verb=DEFAULT_VERBOSITY)=0
 remove entities from given refinement level to finite element database
 
virtual MoFEMErrorCode remove_ents_from_finite_element (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)=0
 remove entities from finite element database
 
virtual MoFEMErrorCode remove_ents_from_finite_element (const Range ents, int verb=DEFAULT_VERBOSITY)=0
 remove entities from finite elements in database
 
virtual MoFEMErrorCode add_ents_to_finite_element_by_MESHSET (const EntityHandle meshset, const std::string &name, const bool recursive=false)=0
 add MESHSET element to finite element database given by name
 
virtual MoFEMErrorCode list_finite_elements () const =0
 list finite elements in database
 
virtual MoFEMErrorCode add_problem (const std::string &name, enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)=0
 Add problem.
 
virtual bool check_problem (const std::string name)=0
 check if problem exist
 
virtual MoFEMErrorCode delete_problem (const std::string name)=0
 Delete problem.
 
virtual MoFEMErrorCode modify_problem_add_finite_element (const std::string name_problem, const std::string &fe_name)=0
 add finite element to problem, this add entities assigned to finite element to a particular problem
 
virtual MoFEMErrorCode modify_problem_unset_finite_element (const std::string name_problem, const std::string &fe_name)=0
 unset finite element from problem, this remove entities assigned to finite element to a particular problem
 
virtual MoFEMErrorCode modify_problem_ref_level_add_bit (const std::string &name_problem, const BitRefLevel &bit)=0
 add ref level to problem
 
virtual MoFEMErrorCode modify_problem_mask_ref_level_add_bit (const std::string &name_problem, const BitRefLevel &bit)=0
 set dof mask ref level for problem
 
virtual MoFEMErrorCode modify_problem_ref_level_set_bit (const std::string &name_problem, const BitRefLevel &bit)=0
 set ref level for problem
 
virtual MoFEMErrorCode modify_problem_mask_ref_level_set_bit (const std::string &name_problem, const BitRefLevel &bit)=0
 set dof mask ref level for problem
 
virtual MoFEMErrorCode list_problem () const =0
 list problems
 
virtual MoFEMErrorCode clear_problem (const std::string name, int verb=DEFAULT_VERBOSITY)=0
 clear problem
 
virtual MoFEMErrorCode clear_problems (int verb=DEFAULT_VERBOSITY)=0
 clear problems
 
virtual MoFEMErrorCode get_problem_finite_elements_entities (const std::string name, const std::string &fe_name, const EntityHandle meshset)=0
 add finite elements to the meshset
 
virtual MoFEMErrorCode list_dofs_by_field_name (const std::string &name) const =0
 
virtual MoFEMErrorCode clear_inactive_dofs (int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode clear_dofs_fields_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode clear_dofs_fields (const Range ents, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode clear_dofs_fields (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode clear_ents_fields (const Range ents, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode clear_ents_fields (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode clear_ents_fields_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode build_finite_elements (int verb=DEFAULT_VERBOSITY)=0
 Build finite elements.
 
virtual MoFEMErrorCode build_finite_elements (const string fe_name, const Range *const ents_ptr=nullptr, int verb=DEFAULT_VERBOSITY)=0
 Build finite elements.
 
virtual MoFEMErrorCode clear_finite_elements_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode clear_finite_elements (const Range &ents, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode clear_finite_elements (const std::string &fe_name, const Range &ents, int verb=DEFAULT_VERBOSITY)=0
 
virtual MoFEMErrorCode build_adjacencies (const Range &ents, int verb=DEFAULT_VERBOSITY)=0
 build adjacencies
 
virtual MoFEMErrorCode build_adjacencies (const BitRefLevel &bit, int verb=DEFAULT_VERBOSITY)=0
 build adjacencies
 
virtual MoFEMErrorCode build_adjacencies (const BitRefLevel &bit, const BitRefLevel &mask, int verb=DEFAULT_VERBOSITY)=0
 build adjacencies
 
virtual MoFEMErrorCode clear_adjacencies_finite_elements (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 clear adjacency map for finite elements on given bit level
 
virtual MoFEMErrorCode clear_adjacencies_entities (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0
 clear adjacency map for entities on given bit level
 
virtual MoFEMErrorCode clear_adjacencies_entities (const Range ents, int verb=DEFAULT_VERBOSITY)=0
 clear adjacencies for field entities by entities
 
virtual MoFEMErrorCode clear_adjacencies_entities (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)=0
 clear adjacencies for field entities by entities and field namd
 
virtual MoFEMErrorCode problem_basic_method_preProcess (const Problem *problem_ptr, BasicMethod &method, int verb=DEFAULT_VERBOSITY)=0
 Set data for BasicMethod.
 
virtual MoFEMErrorCode problem_basic_method_preProcess (const std::string &problem_name, BasicMethod &method, int verb=DEFAULT_VERBOSITY)=0
 Set data for BasicMethod.
 
virtual MoFEMErrorCode problem_basic_method_postProcess (const Problem *problem_ptr, BasicMethod &method, int verb=DEFAULT_VERBOSITY)=0
 Set data for BasicMethod.
 
virtual MoFEMErrorCode problem_basic_method_postProcess (const std::string &problem_name, BasicMethod &method, int verb=DEFAULT_VERBOSITY)=0
 Set data for BasicMethod.
 
virtual MoFEMErrorCode cache_problem_entities (const std::string prb_name, CacheTupleWeakPtr cache_ptr)=0
 Cache variables.
 
virtual 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)=0
 Make a loop over finite elements.
 
virtual 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)=0
 Make a loop over finite elements on partitions from upper to lower rank.
 
virtual 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)=0
 Make a loop over finite elements on partitions from upper to lower rank.
 
virtual 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)=0
 Make a loop over dofs.
 
virtual 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)=0
 Make a loop over dofs.
 
virtual MoFEMErrorCode loop_dofs (const std::string &problem_name, const std::string &field_name, RowColData rc, DofMethod &method, int verb=DEFAULT_VERBOSITY)=0
 Make a loop over dofs.
 
virtual MoFEMErrorCode loop_dofs (const std::string &field_name, DofMethod &method, int verb=DEFAULT_VERBOSITY)=0
 Make a loop over dofs.
 
virtual MoFEMErrorCode loop_entities (const std::string field_name, EntityMethod &method, Range const *const ents=nullptr, int verb=DEFAULT_VERBOSITY)=0
 Loop over field entities.
 
virtual 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)=0
 Loop over field entities in the problem.
 
virtual 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)=0
 Loop over field entities in the problem.
 
virtual MoFEMErrorCode loop_entities (const std::string problem_name, const std::string field_name, RowColData rc, EntityMethod &method, int verb=DEFAULT_VERBOSITY)=0
 Loop over field entities in the problem.
 
virtual const Field_multiIndexget_fields () const =0
 Get the fields object.
 
virtual const RefEntity_multiIndexget_ref_ents () const =0
 Get the ref ents object.
 
virtual const RefElement_multiIndexget_ref_finite_elements () const =0
 Get the ref finite elements object.
 
virtual const FiniteElement_multiIndexget_finite_elements () const =0
 Get the finite elements object.
 
virtual const EntFiniteElement_multiIndexget_ents_finite_elements () const =0
 Get the ents finite elements object.
 
virtual const FieldEntity_multiIndexget_field_ents () const =0
 Get the field ents object.
 
virtual const DofEntity_multiIndexget_dofs () const =0
 Get the dofs object.
 
virtual const Problemget_problem (const std::string problem_name) const =0
 Get the problem object.
 
virtual const Problem_multiIndexget_problems () const =0
 Get the problems object.
 
virtual MoFEMErrorCode get_ents_elements_adjacency (const FieldEntityEntFiniteElementAdjacencyMap_multiIndex **dofs_elements_adjacency) const =0
 Get the dofs elements adjacency object.
 
virtual const FieldEntityEntFiniteElementAdjacencyMap_multiIndexget_ents_elements_adjacency () const =0
 Get the dofs elements adjacency object.
 
virtual MoFEMErrorCode get_fields (const Field_multiIndex **fields_ptr) const =0
 Get fields multi-index from database.
 
virtual MoFEMErrorCode get_ref_ents (const RefEntity_multiIndex **refined_ents_ptr) const =0
 Get ref entities multi-index from database.
 
virtual MoFEMErrorCode get_ref_finite_elements (const RefElement_multiIndex **refined_finite_elements_ptr) const =0
 Get ref finite elements multi-index form database.
 
virtual MoFEMErrorCode get_finite_elements (const FiniteElement_multiIndex **fe_ptr) const =0
 Get finite elements multi-index.
 
virtual MoFEMErrorCode get_ents_finite_elements (const EntFiniteElement_multiIndex **fe_ent_ptr) const =0
 Get entities finite elements multi-index.
 
virtual MoFEMErrorCode get_problem (const std::string &problem_name, const Problem **problem_ptr) const =0
 Get problem database (data structure)
 
virtual MoFEMErrorCode get_problems (const Problem_multiIndex **problems_ptr) const =0
 Get pointer to problems multi-index.
 
virtual MoFEMErrorCode get_field_ents (const FieldEntity_multiIndex **field_ents) const =0
 Get field multi index.
 
virtual MoFEMErrorCode get_dofs (const DofEntity_multiIndex **dofs_ptr) const =0
 Get dofs multi index.
 
virtual FieldEntityByUId::iterator get_ent_field_by_name_begin (const std::string &field_name) const =0
 get begin iterator of field ents of given name (instead you can use IT_GET_ENT_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)
 
virtual FieldEntityByUId::iterator get_ent_field_by_name_end (const std::string &field_name) const =0
 get begin iterator of field dofs of given name (instead you can use IT_GET_ENT_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)
 
virtual DofEntityByUId::iterator get_dofs_by_name_begin (const std::string &field_name) const =0
 get begin iterator of field dofs of given name (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)
 
virtual DofEntityByUId::iterator get_dofs_by_name_end (const std::string &field_name) const =0
 get begin iterator of field dofs of given name (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)
 
virtual DofEntityByUId::iterator get_dofs_by_name_and_ent_begin (const std::string &field_name, const EntityHandle ent) const =0
 get begin iterator of field dofs of given name and ent(instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,ENT,IT)
 
virtual DofEntityByUId::iterator get_dofs_by_name_and_ent_end (const std::string &field_name, const EntityHandle ent) const =0
 get begin iterator of field dofs of given name and ent (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,ENT,IT)
 
virtual DofEntityByUId::iterator get_dofs_by_name_and_type_begin (const std::string &field_name, const EntityType type) const =0
 get begin iterator of field dofs of given name and ent type (instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,TYPE,IT)
 
virtual DofEntityByUId::iterator get_dofs_by_name_and_type_end (const std::string &field_name, const EntityType type) const =0
 get begin iterator of field dofs of given name end ent type(instead you can use IT_GET_DOFS_FIELD_BY_NAME_FOR_LOOP(MFIELD,NAME,TYPE,IT)
 
virtual EntFiniteElement_multiIndex::index< Unique_mi_tag >::type::iterator get_fe_by_name_begin (const std::string &fe_name) const =0
 get begin iterator of finite elements of given name (instead you can use IT_GET_FES_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)
 
virtual EntFiniteElement_multiIndex::index< Unique_mi_tag >::type::iterator get_fe_by_name_end (const std::string &fe_name) const =0
 get end iterator of finite elements of given name (instead you can use IT_GET_FES_BY_NAME_FOR_LOOP(MFIELD,NAME,IT)
 
- Public Member Functions inherited from MoFEM::UnknownInterface
virtual MoFEMErrorCode query_interface (boost::typeindex::type_index type_index, UnknownInterface **iface) const =0
 
template<class IFACE >
MoFEMErrorCode registerInterface (bool error_if_registration_failed=true)
 Register interface.
 
template<class IFACE >
MoFEMErrorCode getInterface (IFACE *&iface) const
 Get interface reference to pointer of interface.
 
template<class IFACE >
MoFEMErrorCode getInterface (IFACE **const iface) const
 Get interface pointer to pointer of interface.
 
template<class IFACE , typename boost::enable_if< boost::is_pointer< IFACE >, int >::type = 0>
IFACE getInterface () const
 Get interface pointer to pointer of interface.
 
template<class IFACE , typename boost::enable_if< boost::is_reference< IFACE >, int >::type = 0>
IFACE getInterface () const
 Get reference to interface.
 
template<class IFACE >
IFACE * getInterface () const
 Function returning pointer to interface.
 
virtual ~UnknownInterface ()=default
 
- Static Public Member Functions inherited from MoFEM::UnknownInterface
static MoFEMErrorCode getLibVersion (Version &version)
 Get library version.
 
static MoFEMErrorCode getFileVersion (moab::Interface &moab, Version &version)
 Get database major version.
 
static MoFEMErrorCode setFileVersion (moab::Interface &moab, Version version=Version(MoFEM_VERSION_MAJOR, MoFEM_VERSION_MINOR, MoFEM_VERSION_BUILD))
 Get database major version.
 
static MoFEMErrorCode getInterfaceVersion (Version &version)
 Get database major version.
 

Detailed Description

Deprecated interface functions.

Examples
ADOLCPlasticity.hpp, ADOLCPlasticityLargeStrain.hpp, ADOLCPlasticityMaterialModels.hpp, AuxPoissonFunctions.hpp, ContactOps.hpp, ElasticityMixedFormulation.hpp, EshelbianPlasticity.cpp, ExampleArcLength.hpp, ExampleNonlinearElastic.hpp, HenckyOps.hpp, HookeElement.cpp, HookeElement.hpp, MagneticElement.hpp, NavierStokesElement.hpp, NonlinearElasticElementInterface.hpp, PlasticOps.hpp, PlasticOpsMonitor.hpp, PoissonOperators.hpp, Remodeling.cpp, Remodeling.hpp, ThermoElasticOps.hpp, UnsaturatedFlow.hpp, 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, 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, dg_projection.cpp, dm_build_partitioned_mesh.cpp, dm_create_subdm.cpp, dm_partitioned_no_field.cpp, dynamic_first_order_con_law.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, hanging_node_approx.cpp, hcurl_check_approx_in_2d.cpp, hcurl_curl_operator.cpp, hcurl_divergence_operator_2d.cpp, hdiv_check_approx_in_3d.cpp, hdiv_divergence_operator.cpp, heat_equation.cpp, heat_method.cpp, hello_world.cpp, helmholtz.cpp, higher_derivatives.cpp, level_set.cpp, log.cpp, loop_entities.cpp, lorentz_force.cpp, magnetostatic.cpp, mesh_insert_interface_atom.cpp, mesh_smoothing.cpp, meshset_to_vtk.cpp, minimal_surface_area.cpp, mixed_poisson.cpp, mofem/tutorials/vec-7/adjoint.cpp, navier_stokes.cpp, node_merge.cpp, nonlinear_dynamics.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_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, testing_jacobian_of_hook_element.cpp, testing_jacobian_of_hook_scaled_with_density_element.cpp, thermo_elastic.cpp, unsaturated_transport.cpp, and wave_equation.cpp.

Definition at line 16 of file DeprecatedCoreInterface.hpp.

Member Function Documentation

◆ partition_mesh()

MoFEMErrorCode MoFEM::DeprecatedCoreInterface::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.

This will use one of the mesh partitioning programs available from PETSc See http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPartitioningType.html

Parameters
entsEntities to partition
dimDimension of entities to partition
adj_dimAdjacency dimension
n_partsNumber of partitions
verbVerbosity level
Returns
Error code

Definition at line 32 of file DeprecatedCoreInterface.cpp.

36 {
37 return getInterface<CommInterface>()->partitionMesh(
38 ents, dim, adj_dim, n_parts, NULL, NULL, NULL, verb);
39}
IFACE getInterface() const
Get interface pointer to pointer of interface.

◆ seed_ref_level()

MoFEMErrorCode MoFEM::DeprecatedCoreInterface::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

Deprecated
use BitRefManager
Todo
Should be outsourced to separate interface, i.e. BitLevelManager

Definition at line 24 of file DeprecatedCoreInterface.cpp.

27 {
28 return getInterface<BitRefManager>()->setBitRefLevel(ents, bit, only_tets,
29 verb);
30}
auto bit
set bit

◆ seed_ref_level_2D()

MoFEMErrorCode MoFEM::DeprecatedCoreInterface::seed_ref_level_2D ( const EntityHandle meshset,
const BitRefLevel & bit,
int verb = -1 )
virtual

seed 2D entities (Triangles entities only) in the meshset and their adjacencies (only TRIs adjacencies) in a particular BitRefLevel

Deprecated
use BitRefManager
Todo
Should be outsourced to separate interface, i.e. BitLevelManager
Parameters
EntityHandleMeshSet
BitRefLevelbitLevel

Definition at line 11 of file DeprecatedCoreInterface.cpp.

12 {
13 return getInterface<BitRefManager>()->setBitRefLevelByDim(meshset, 2, bit,
14 verb);
15}

◆ seed_ref_level_3D()

MoFEMErrorCode MoFEM::DeprecatedCoreInterface::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

Deprecated
use BitRefManager
Todo
Should be outsourced to separate interface, i.e. BitLevelManager
Parameters
EntityHandleMeshSet
BitRefLevelbitLevel

Example:

EntityHandle meshset1; //contains ent1,ent2,ent3
BitRefLevel myLevel0;
myLevel0.set(0);
seed_ref_level_3D(meshset1,myLevel0);
//refine meshset1 into meshset2 and get new ents which are ent4, ent5
EntityHandle meshset2; //contains ent1,ent2,ent3,ent4,ent5
BitRefLevel myLevel1;
myLevel1.set(1);
seed_ref_level_3D(meshset2,myLevel1);
std::bitset< BITREFLEVEL_SIZE > BitRefLevel
Bit structure attached to each entity identifying to what mesh entity is attached.
Definition Types.hpp:40
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 BitRefL...

So entities 1,2,3 would be assigned to bit level 0 and 1
ent1[1,1,0,0,0,0,0], ent2[1,1,0,0,0,0,0], ent3[1,1,0,0,0,0,0],
and entities 4 and 5 are assigned to bit level 1 only
ent4[0,1,0,0,0,0,0], ent5[0,1,0,0,0,0,0]

Definition at line 18 of file DeprecatedCoreInterface.cpp.

19 {
20 return getInterface<BitRefManager>()->setBitRefLevelByDim(meshset, 3, bit,
21 verb);
22}

◆ synchronise_entities()

MoFEMErrorCode MoFEM::DeprecatedCoreInterface::synchronise_entities ( Range & ent,
int verb = DEFAULT_VERBOSITY )

synchronize entity range on processors (collective)

collective - need tu be run on all processors in communicator

Deprecated
Use Comm Interface

Definition at line 41 of file DeprecatedCoreInterface.cpp.

42 {
43 return getInterface<CommInterface>()->synchroniseEntities(ent, nullptr, verb);
44}

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