v0.14.0 |
Deprecated interface functions. More...
#include <src/interfaces/DeprecatedCoreInterface.hpp>
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 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... | |
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. More... | |
virtual boost::shared_ptr< RefEntityTmp< 0 > > | make_shared_ref_entity (const EntityHandle ent)=0 |
Get RefEntity. More... | |
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. More... | |
virtual MeshsetsManager * | get_meshsets_manager_ptr ()=0 |
get MeshsetsManager pointer More... | |
virtual const MeshsetsManager * | get_meshsets_manager_ptr () const =0 |
get MeshsetsManager pointer More... | |
virtual MeshsetsManager & | get_meshsets_manager ()=0 |
get MeshsetsManager pointer More... | |
virtual const MeshsetsManager & | get_meshsets_manager () const =0 |
get MeshsetsManager pointer More... | |
virtual boost::shared_ptr< BasicEntityData > & | get_basic_entity_data_ptr ()=0 |
Get pointer to basic entity data. More... | |
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 More... | |
virtual MoFEMErrorCode | check_number_of_ents_in_ents_field () const =0 |
check data consistency in entitiesPtr More... | |
virtual MoFEMErrorCode | check_number_of_ents_in_ents_finite_element (const std::string &name) const =0 |
check data consistency in entsFiniteElements More... | |
virtual MoFEMErrorCode | check_number_of_ents_in_ents_finite_element () const =0 |
check data consistency in entsFiniteElements More... | |
virtual MoFEMErrorCode | clear_database (int verb=DEFAULT_VERBOSITY)=0 |
Clear database. More... | |
virtual MoFEMErrorCode | rebuild_database (int verb=DEFAULT_VERBOSITY)=0 |
Clear database and initialize it once again. More... | |
virtual MoFEMErrorCode | remove_parents_by_ents (const Range &ents, int verb=DEFAULT_VERBOSITY)=0 |
Remove parents from entities. More... | |
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. More... | |
virtual MoFEMErrorCode | remove_parents_by_parents (const Range &ents, int verb=DEFAULT_VERBOSITY)=0 |
Remove paremts from entities having parents in passed range. More... | |
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 More... | |
virtual MoFEMErrorCode | remove_ents (const Range ents, int verb=DEFAULT_VERBOSITY)=0 |
remove entities form mofem database More... | |
virtual MoFEMErrorCode | remove_ents_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0 |
remove entities form mofem database More... | |
virtual MoFEMErrorCode | delete_finite_element (const std::string name, int verb=DEFAULT_VERBOSITY)=0 |
delete finite element from mofem database More... | |
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. More... | |
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. More... | |
virtual MoFEMErrorCode | delete_field (const std::string name, int verb=DEFAULT_VERBOSITY)=0 |
Delete field. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
virtual MoFEMErrorCode | remove_ents_from_field_by_bit_ref (const BitRefLevel bit, const BitRefLevel mask, int verb=DEFAULT_VERBOSITY)=0 |
remove entities from field More... | |
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 More... | |
virtual MoFEMErrorCode | remove_ents_from_field (const std::string name, const Range ents, int verb=DEFAULT_VERBOSITY)=0 |
remove entities from field More... | |
virtual MoFEMErrorCode | remove_ents_from_field (const Range ents, int verb=DEFAULT_VERBOSITY)=0 |
remove entities from all fields More... | |
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. More... | |
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. More... | |
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. More... | |
virtual MoFEMErrorCode | list_fields () const =0 |
list entities in the field More... | |
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 More... | |
virtual BitFieldId | get_field_id (const std::string &name) const =0 |
Get field Id. More... | |
virtual FieldBitNumber | get_field_bit_number (const std::string name) const =0 |
get field bit number More... | |
virtual std::string | get_field_name (const BitFieldId id) const =0 |
get field name from id More... | |
virtual EntityHandle | get_field_meshset (const std::string name) const =0 |
get field meshset More... | |
virtual MoFEMErrorCode | get_field_entities_by_dimension (const std::string name, int dim, Range &ents) const =0 |
get entities in the field by dimension More... | |
virtual MoFEMErrorCode | get_field_entities_by_type (const std::string name, EntityType type, Range &ents) const =0 |
get entities in the field by type More... | |
virtual MoFEMErrorCode | get_field_entities_by_handle (const std::string name, Range &ents) const =0 |
get entities in the field by handle More... | |
virtual bool | check_field (const std::string &name) const =0 |
check if field is in database More... | |
virtual const Field * | get_field_structure (const std::string &name, enum MoFEMTypes bh=MF_EXIST) const =0 |
get field structure More... | |
virtual const FiniteElement * | get_finite_element_structure (const std::string &name, enum MoFEMTypes bh=MF_EXIST) const =0 |
get finite element struture More... | |
virtual bool | check_finite_element (const std::string &name) const =0 |
Check if finite element is in database. More... | |
virtual MoFEMErrorCode | add_finite_element (const std::string &fe_name, enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)=0 |
add finite element More... | |
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 More... | |
virtual MoFEMErrorCode | modify_finite_element_add_field_data (const std::string &fe_name, const std::string name_field)=0 |
set finite element field data More... | |
virtual MoFEMErrorCode | modify_finite_element_off_field_data (const std::string &fe_name, const std::string name_field)=0 |
unset finite element field data More... | |
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 More... | |
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 More... | |
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 More... | |
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 More... | |
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 More... | |
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 More... | |
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 More... | |
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 More... | |
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 More... | |
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 More... | |
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 More... | |
virtual MoFEMErrorCode | get_finite_element_entities_by_handle (const std::string name, Range &ents) const =0 |
get entities in the finite element by handle More... | |
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 More... | |
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 More... | |
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 More... | |
virtual MoFEMErrorCode | remove_ents_from_finite_element (const Range ents, int verb=DEFAULT_VERBOSITY)=0 |
remove entities from finite elements in database More... | |
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 More... | |
virtual MoFEMErrorCode | list_finite_elements () const =0 |
list finite elements in database More... | |
virtual MoFEMErrorCode | add_problem (const std::string &name, enum MoFEMTypes bh=MF_EXCL, int verb=DEFAULT_VERBOSITY)=0 |
Add problem. More... | |
virtual bool | check_problem (const std::string name)=0 |
check if problem exist More... | |
virtual MoFEMErrorCode | delete_problem (const std::string name)=0 |
Delete problem. More... | |
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 More... | |
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 More... | |
virtual MoFEMErrorCode | modify_problem_ref_level_add_bit (const std::string &name_problem, const BitRefLevel &bit)=0 |
add ref level to problem More... | |
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 More... | |
virtual MoFEMErrorCode | modify_problem_ref_level_set_bit (const std::string &name_problem, const BitRefLevel &bit)=0 |
set ref level for problem More... | |
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 More... | |
virtual MoFEMErrorCode | list_problem () const =0 |
list problems More... | |
virtual MoFEMErrorCode | clear_problem (const std::string name, int verb=DEFAULT_VERBOSITY)=0 |
clear problem More... | |
virtual MoFEMErrorCode | clear_problems (int verb=DEFAULT_VERBOSITY)=0 |
clear problems More... | |
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 More... | |
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. More... | |
virtual MoFEMErrorCode | build_finite_elements (const string fe_name, const Range *const ents_ptr=nullptr, int verb=DEFAULT_VERBOSITY)=0 |
Build finite elements. More... | |
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 More... | |
virtual MoFEMErrorCode | build_adjacencies (const BitRefLevel &bit, int verb=DEFAULT_VERBOSITY)=0 |
build adjacencies More... | |
virtual MoFEMErrorCode | build_adjacencies (const BitRefLevel &bit, const BitRefLevel &mask, int verb=DEFAULT_VERBOSITY)=0 |
build adjacencies More... | |
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 More... | |
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 More... | |
virtual MoFEMErrorCode | clear_adjacencies_entities (const Range ents, int verb=DEFAULT_VERBOSITY)=0 |
clear adjacencies for field entities by entities More... | |
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 More... | |
virtual MoFEMErrorCode | problem_basic_method_preProcess (const Problem *problem_ptr, BasicMethod &method, int verb=DEFAULT_VERBOSITY)=0 |
Set data for BasicMethod. More... | |
virtual MoFEMErrorCode | problem_basic_method_preProcess (const std::string &problem_name, BasicMethod &method, int verb=DEFAULT_VERBOSITY)=0 |
Set data for BasicMethod. More... | |
virtual MoFEMErrorCode | problem_basic_method_postProcess (const Problem *problem_ptr, BasicMethod &method, int verb=DEFAULT_VERBOSITY)=0 |
Set data for BasicMethod. More... | |
virtual MoFEMErrorCode | problem_basic_method_postProcess (const std::string &problem_name, BasicMethod &method, int verb=DEFAULT_VERBOSITY)=0 |
Set data for BasicMethod. More... | |
virtual MoFEMErrorCode | cache_problem_entities (const std::string prb_name, CacheTupleWeakPtr cache_ptr)=0 |
Cache variables. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
virtual MoFEMErrorCode | loop_dofs (const std::string &field_name, DofMethod &method, int verb=DEFAULT_VERBOSITY)=0 |
Make a loop over dofs. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
virtual const Field_multiIndex * | get_fields () const =0 |
Get the fields object. More... | |
virtual const RefEntity_multiIndex * | get_ref_ents () const =0 |
Get the ref ents object. More... | |
virtual const RefElement_multiIndex * | get_ref_finite_elements () const =0 |
Get the ref finite elements object. More... | |
virtual const FiniteElement_multiIndex * | get_finite_elements () const =0 |
Get the finite elements object. More... | |
virtual const EntFiniteElement_multiIndex * | get_ents_finite_elements () const =0 |
Get the ents finite elements object. More... | |
virtual const FieldEntity_multiIndex * | get_field_ents () const =0 |
Get the field ents object. More... | |
virtual const DofEntity_multiIndex * | get_dofs () const =0 |
Get the dofs object. More... | |
virtual const Problem * | get_problem (const std::string problem_name) const =0 |
Get the problem object. More... | |
virtual const Problem_multiIndex * | get_problems () const =0 |
Get the problems object. More... | |
virtual MoFEMErrorCode | get_ents_elements_adjacency (const FieldEntityEntFiniteElementAdjacencyMap_multiIndex **dofs_elements_adjacency) const =0 |
Get the dofs elements adjacency object. More... | |
virtual const FieldEntityEntFiniteElementAdjacencyMap_multiIndex * | get_ents_elements_adjacency () const =0 |
Get the dofs elements adjacency object. More... | |
virtual MoFEMErrorCode | get_fields (const Field_multiIndex **fields_ptr) const =0 |
Get fields multi-index from database. More... | |
virtual MoFEMErrorCode | get_ref_ents (const RefEntity_multiIndex **refined_ents_ptr) const =0 |
Get ref entities multi-index from database. More... | |
virtual MoFEMErrorCode | get_ref_finite_elements (const RefElement_multiIndex **refined_finite_elements_ptr) const =0 |
Get ref finite elements multi-index form database. More... | |
virtual MoFEMErrorCode | get_finite_elements (const FiniteElement_multiIndex **fe_ptr) const =0 |
Get finite elements multi-index. More... | |
virtual MoFEMErrorCode | get_ents_finite_elements (const EntFiniteElement_multiIndex **fe_ent_ptr) const =0 |
Get entities finite elements multi-index. More... | |
virtual MoFEMErrorCode | get_problem (const std::string &problem_name, const Problem **problem_ptr) const =0 |
Get problem database (data structure) More... | |
virtual MoFEMErrorCode | get_problems (const Problem_multiIndex **problems_ptr) const =0 |
Get pointer to problems multi-index. More... | |
virtual MoFEMErrorCode | get_field_ents (const FieldEntity_multiIndex **field_ents) const =0 |
Get field multi index. More... | |
virtual MoFEMErrorCode | get_dofs (const DofEntity_multiIndex **dofs_ptr) const =0 |
Get dofs multi index. More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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. 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 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... | |
Deprecated interface functions.
Definition at line 16 of file DeprecatedCoreInterface.hpp.
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
ents | Entities to partition |
dim | Dimension of entities to partition |
adj_dim | Adjacency dimension |
n_parts | Number of partitions |
verb | Verbosity level |
Definition at line 32 of file DeprecatedCoreInterface.cpp.
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
Definition at line 24 of file DeprecatedCoreInterface.cpp.
|
virtual |
seed 2D entities (Triangles entities only) in the meshset and their adjacencies (only TRIs adjacencies) in a particular BitRefLevel
EntityHandle | MeshSet |
BitRefLevel | bitLevel |
Definition at line 11 of file DeprecatedCoreInterface.cpp.
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
EntityHandle | MeshSet |
BitRefLevel | bitLevel |
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.
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
Definition at line 41 of file DeprecatedCoreInterface.cpp.