|
| Triangulation (MPI_Comm mpi_communicator, const typename ::Triangulation< 1, spacedim >::MeshSmoothing smooth_grid=(::Triangulation< 1, spacedim >::none), const Settings settings=default_setting) |
|
virtual | ~Triangulation () override |
|
const std::vector< types::global_dof_index > & | get_p4est_tree_to_coarse_cell_permutation () const |
|
void | communicate_locally_moved_vertices (const std::vector< bool > &vertex_locally_moved) |
|
void | load (const std::string &filename, const bool autopartition=true) |
|
void | save (const std::string &filename) const |
|
unsigned int | register_data_attach (const std::function< std::vector< char >(const typename ::Triangulation< 1, spacedim >::cell_iterator &, const typename ::Triangulation< 1, spacedim >::CellStatus)> &pack_callback, const bool returns_variable_size_data) |
|
void | notify_ready_to_unpack (const unsigned int handle, const std::function< void(const typename ::Triangulation< 1, spacedim >::cell_iterator &, const typename ::Triangulation< 1, spacedim >::CellStatus, const boost::iterator_range< std::vector< char >::const_iterator > &)> &unpack_callback) |
|
virtual std::map< unsigned int, std::set<::types::subdomain_id > > | compute_vertices_with_ghost_neighbors () const override |
|
virtual std::map< unsigned int, std::set<::types::subdomain_id > > | compute_level_vertices_with_ghost_neighbors (const unsigned int level) const |
|
virtual std::vector< bool > | mark_locally_active_vertices_on_level (const unsigned int level) const |
|
| Triangulation (MPI_Comm mpi_communicator, const typename ::Triangulation< dim, spacedim >::MeshSmoothing smooth_grid=(::Triangulation< dim, spacedim >::none), const bool check_for_distorted_cells=false) |
|
virtual MPI_Comm | get_communicator () const |
|
virtual void | copy_triangulation (const ::Triangulation< dim, spacedim > &old_tria) override |
|
const std::vector< unsigned int > & | n_locally_owned_active_cells_per_processor () const |
|
unsigned int | n_locally_owned_active_cells () const |
|
virtual types::global_dof_index | n_global_active_cells () const override |
|
virtual std::size_t | memory_consumption () const override |
|
virtual unsigned int | n_global_levels () const override |
|
types::subdomain_id | locally_owned_subdomain () const override |
|
const std::set< types::subdomain_id > & | ghost_owners () const |
|
const std::set< types::subdomain_id > & | level_ghost_owners () const |
|
| Triangulation (const MeshSmoothing smooth_grid=none, const bool check_for_distorted_cells=false) |
|
| Triangulation (const Triangulation< dim, spacedim > &)=delete |
|
| Triangulation (Triangulation< dim, spacedim > &&tria) noexcept |
|
Triangulation & | operator= (Triangulation< dim, spacedim > &&tria) noexcept |
|
virtual void | clear () |
|
virtual void | set_mesh_smoothing (const MeshSmoothing mesh_smoothing) |
|
virtual const MeshSmoothing & | get_mesh_smoothing () const |
|
void | set_manifold (const types::manifold_id number, const Manifold< dim, spacedim > &manifold_object) |
|
void | set_manifold (const types::manifold_id number) |
|
void | reset_manifold (const types::manifold_id manifold_number) |
|
void | reset_all_manifolds () |
|
void | set_all_manifold_ids (const types::manifold_id number) |
|
void | set_all_manifold_ids_on_boundary (const types::manifold_id number) |
|
void | set_all_manifold_ids_on_boundary (const types::boundary_id b_id, const types::manifold_id number) |
|
const Manifold< dim, spacedim > & | get_manifold (const types::manifold_id number) const |
|
std::vector< types::boundary_id > | get_boundary_ids () const |
|
std::vector< types::manifold_id > | get_manifold_ids () const |
|
virtual void | copy_triangulation (const Triangulation< dim, spacedim > &other_tria) |
|
virtual void | create_triangulation (const std::vector< Point< spacedim >> &vertices, const std::vector< CellData< dim >> &cells, const SubCellData &subcelldata) |
|
virtual void | create_triangulation_compatibility (const std::vector< Point< spacedim >> &vertices, const std::vector< CellData< dim >> &cells, const SubCellData &subcelldata) |
|
void | flip_all_direction_flags () |
|
void | set_all_refine_flags () |
|
void | refine_global (const unsigned int times=1) |
|
virtual void | execute_coarsening_and_refinement () |
|
virtual bool | prepare_coarsening_and_refinement () |
|
void | save_refine_flags (std::ostream &out) const |
|
void | save_refine_flags (std::vector< bool > &v) const |
|
void | load_refine_flags (std::istream &in) |
|
void | load_refine_flags (const std::vector< bool > &v) |
|
void | save_coarsen_flags (std::ostream &out) const |
|
void | save_coarsen_flags (std::vector< bool > &v) const |
|
void | load_coarsen_flags (std::istream &out) |
|
void | load_coarsen_flags (const std::vector< bool > &v) |
|
bool | get_anisotropic_refinement_flag () const |
|
void | clear_user_flags () |
|
void | save_user_flags (std::ostream &out) const |
|
void | save_user_flags (std::vector< bool > &v) const |
|
void | load_user_flags (std::istream &in) |
|
void | load_user_flags (const std::vector< bool > &v) |
|
void | clear_user_flags_line () |
|
void | save_user_flags_line (std::ostream &out) const |
|
void | save_user_flags_line (std::vector< bool > &v) const |
|
void | load_user_flags_line (std::istream &in) |
|
void | load_user_flags_line (const std::vector< bool > &v) |
|
void | clear_user_flags_quad () |
|
void | save_user_flags_quad (std::ostream &out) const |
|
void | save_user_flags_quad (std::vector< bool > &v) const |
|
void | load_user_flags_quad (std::istream &in) |
|
void | load_user_flags_quad (const std::vector< bool > &v) |
|
void | clear_user_flags_hex () |
|
void | save_user_flags_hex (std::ostream &out) const |
|
void | save_user_flags_hex (std::vector< bool > &v) const |
|
void | load_user_flags_hex (std::istream &in) |
|
void | load_user_flags_hex (const std::vector< bool > &v) |
|
void | clear_user_data () |
|
void | save_user_indices (std::vector< unsigned int > &v) const |
|
void | load_user_indices (const std::vector< unsigned int > &v) |
|
void | save_user_pointers (std::vector< void *> &v) const |
|
void | load_user_pointers (const std::vector< void *> &v) |
|
void | save_user_indices_line (std::vector< unsigned int > &v) const |
|
void | load_user_indices_line (const std::vector< unsigned int > &v) |
|
void | save_user_indices_quad (std::vector< unsigned int > &v) const |
|
void | load_user_indices_quad (const std::vector< unsigned int > &v) |
|
void | save_user_indices_hex (std::vector< unsigned int > &v) const |
|
void | load_user_indices_hex (const std::vector< unsigned int > &v) |
|
void | save_user_pointers_line (std::vector< void *> &v) const |
|
void | load_user_pointers_line (const std::vector< void *> &v) |
|
void | save_user_pointers_quad (std::vector< void *> &v) const |
|
void | load_user_pointers_quad (const std::vector< void *> &v) |
|
void | save_user_pointers_hex (std::vector< void *> &v) const |
|
void | load_user_pointers_hex (const std::vector< void *> &v) |
|
cell_iterator | begin (const unsigned int level=0) const |
|
active_cell_iterator | begin_active (const unsigned int level=0) const |
|
cell_iterator | end () const |
|
cell_iterator | end (const unsigned int level) const |
|
active_cell_iterator | end_active (const unsigned int level) const |
|
cell_iterator | last () const |
|
active_cell_iterator | last_active () const |
|
IteratorRange< cell_iterator > | cell_iterators () const |
|
IteratorRange< active_cell_iterator > | active_cell_iterators () const |
|
IteratorRange< cell_iterator > | cell_iterators_on_level (const unsigned int level) const |
|
IteratorRange< active_cell_iterator > | active_cell_iterators_on_level (const unsigned int level) const |
|
face_iterator | begin_face () const |
|
active_face_iterator | begin_active_face () const |
|
face_iterator | end_face () const |
|
IteratorRange< active_face_iterator > | active_face_iterators () const |
|
vertex_iterator | begin_vertex () const |
|
active_vertex_iterator | begin_active_vertex () const |
|
vertex_iterator | end_vertex () const |
|
unsigned int | n_lines () const |
|
unsigned int | n_lines (const unsigned int level) const |
|
unsigned int | n_active_lines () const |
|
unsigned int | n_active_lines (const unsigned int level) const |
|
unsigned int | n_quads () const |
|
unsigned int | n_quads (const unsigned int level) const |
|
unsigned int | n_active_quads () const |
|
unsigned int | n_active_quads (const unsigned int level) const |
|
unsigned int | n_hexs () const |
|
unsigned int | n_hexs (const unsigned int level) const |
|
unsigned int | n_active_hexs () const |
|
unsigned int | n_active_hexs (const unsigned int level) const |
|
unsigned int | n_cells () const |
|
unsigned int | n_cells (const unsigned int level) const |
|
unsigned int | n_active_cells () const |
|
unsigned int | n_active_cells (const unsigned int level) const |
|
unsigned int | n_faces () const |
|
unsigned int | n_active_faces () const |
|
unsigned int | n_levels () const |
|
virtual bool | has_hanging_nodes () const |
|
unsigned int | n_vertices () const |
|
const std::vector< Point< spacedim > > & | get_vertices () const |
|
unsigned int | n_used_vertices () const |
|
bool | vertex_used (const unsigned int index) const |
|
const std::vector< bool > & | get_used_vertices () const |
|
unsigned int | max_adjacent_cells () const |
|
Triangulation< dim, spacedim > & | get_triangulation () |
|
const Triangulation< dim, spacedim > & | get_triangulation () const |
|
unsigned int | n_raw_lines () const |
|
unsigned int | n_raw_lines (const unsigned int level) const |
|
unsigned int | n_raw_quads () const |
|
unsigned int | n_raw_quads (const unsigned int level) const |
|
unsigned int | n_raw_hexs (const unsigned int level) const |
|
unsigned int | n_raw_cells (const unsigned int level) const |
|
unsigned int | n_raw_faces () const |
|
template<class Archive > |
void | save (Archive &ar, const unsigned int version) const |
|
template<class Archive > |
void | load (Archive &ar, const unsigned int version) |
|
virtual void | add_periodicity (const std::vector< GridTools::PeriodicFacePair< cell_iterator >> &) |
|
const std::map< std::pair< cell_iterator, unsigned int >, std::pair< std::pair< cell_iterator, unsigned int >, std::bitset< 3 > > > & | get_periodic_face_map () const |
|
| Subscriptor () |
|
| Subscriptor (const Subscriptor &) |
|
| Subscriptor (Subscriptor &&) noexcept |
|
virtual | ~Subscriptor () |
|
Subscriptor & | operator= (const Subscriptor &) |
|
Subscriptor & | operator= (Subscriptor &&) noexcept |
|
void | subscribe (std::atomic< bool > *const validity, const std::string &identifier="") const |
|
void | unsubscribe (std::atomic< bool > *const validity, const std::string &identifier="") const |
|
unsigned int | n_subscriptions () const |
|
template<typename StreamType > |
void | list_subscribers (StreamType &stream) const |
|
void | list_subscribers () const |
|
template<class Archive > |
void | serialize (Archive &ar, const unsigned int version) |
|
template<int spacedim>
class parallel::distributed::Triangulation< 1, spacedim >
Specialization of the general template for the 1d case. There is currently no support for distributing 1d triangulations. Consequently, all this class does is throw an exception.
Definition at line 1235 of file tria.h.