Reference documentation for deal.II version GIT relicensing-233-g802318d791 2024-03-28 20:20:02+00:00
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Static Public Member Functions | Static Public Attributes | List of all members
internal::p4est::functions< 2 > Struct Reference

#include <deal.II/distributed/p4est_wrappers.h>

Static Public Member Functions

template<int spacedim>
static void iterate (::internal::p4est::types< 2 >::forest *parallel_forest, ::internal::p4est::types< 2 >::ghost *parallel_ghost, void *user_data)
 

Static Public Attributes

static int(&) quadrant_compare (const void *v1, const void *v2)
 
static void(&) quadrant_childrenv (const types< 2 >::quadrant *q, types< 2 >::quadrant c[])
 
static int(&) quadrant_overlaps_tree (types< 2 >::tree *tree, const types< 2 >::quadrant *q)
 
static void(&) quadrant_set_morton (types< 2 >::quadrant *quadrant, int level, std::uint64_t id)
 
static int(&) quadrant_is_equal (const types< 2 >::quadrant *q1, const types< 2 >::quadrant *q2)
 
static int(&) quadrant_is_sibling (const types< 2 >::quadrant *q1, const types< 2 >::quadrant *q2)
 
static int(&) quadrant_is_ancestor (const types< 2 >::quadrant *q1, const types< 2 >::quadrant *q2)
 
static int(&) quadrant_ancestor_id (const types< 2 >::quadrant *q, int level)
 
static int(&) comm_find_owner (types< 2 >::forest *p4est, const types< 2 >::locidx which_tree, const types< 2 >::quadrant *q, const int guess)
 
static types< 2 >::connectivity *(&) connectivity_new (types< 2 >::topidx num_vertices, types< 2 >::topidx num_trees, types< 2 >::topidx num_corners, types< 2 >::topidx num_vtt)
 
static types< 2 >::connectivity *(&) connectivity_new_copy (types< 2 >::topidx num_vertices, types< 2 >::topidx num_trees, types< 2 >::topidx num_corners, const double *vertices, const types< 2 >::topidx *ttv, const types< 2 >::topidx *ttt, const int8_t *ttf, const types< 2 >::topidx *ttc, const types< 2 >::topidx *coff, const types< 2 >::topidx *ctt, const int8_t *ctc)
 
static void(&) connectivity_join_faces (types< 2 >::connectivity *conn, types< 2 >::topidx tree_left, types< 2 >::topidx tree_right, int face_left, int face_right, int orientation)
 
static void(&) connectivity_destroy (p4est_connectivity_t *connectivity)
 
static types< 2 >::forest *(&) new_forest (MPI_Comm mpicomm, types< 2 >::connectivity *connectivity, types< 2 >::locidx min_quadrants, int min_level, int fill_uniform, std::size_t data_size, p4est_init_t init_fn, void *user_pointer)
 
static types< 2 >::forest *(&) copy_forest (types< 2 >::forest *input, int copy_data)
 
static void(&) destroy (types< 2 >::forest *p4est)
 
static void(&) refine (types< 2 >::forest *p4est, int refine_recursive, p4est_refine_t refine_fn, p4est_init_t init_fn)
 
static void(&) coarsen (types< 2 >::forest *p4est, int coarsen_recursive, p4est_coarsen_t coarsen_fn, p4est_init_t init_fn)
 
static void(&) balance (types< 2 >::forest *p4est, types< 2 >::balance_type btype, p4est_init_t init_fn)
 
static types< 2 >::gloidx(&) partition (types< 2 >::forest *p4est, int partition_for_coarsening, p4est_weight_t weight_fn)
 
static void(&) save (const char *filename, types< 2 >::forest *p4est, int save_data)
 
static types< 2 >::forest *(&) load_ext (const char *filename, MPI_Comm mpicomm, std::size_t data_size, int load_data, int autopartition, int broadcasthead, void *user_pointer, types< 2 >::connectivity **p4est)
 
static int(&) connectivity_save (const char *filename, types< 2 >::connectivity *connectivity)
 
static int(&) connectivity_is_valid (types< 2 >::connectivity *connectivity)
 
static types< 2 >::connectivity *(&) connectivity_load (const char *filename, std::size_t *length)
 
static unsigned int(&) checksum (types< 2 >::forest *p4est)
 
static void(&) vtk_write_file (types< 2 >::forest *p4est, p4est_geometry_t *, const char *baseName)
 
static types< 2 >::ghost *(&) ghost_new (types< 2 >::forest *p4est, types< 2 >::balance_type btype)
 
static void(&) ghost_destroy (types< 2 >::ghost *ghost)
 
static void(&) reset_data (types< 2 >::forest *p4est, std::size_t data_size, p4est_init_t init_fn, void *user_pointer)
 
static std::size_t(&) forest_memory_used (types< 2 >::forest *p4est)
 
static std::size_t(&) connectivity_memory_used (types< 2 >::connectivity *p4est)
 
static constexpr unsigned int max_level = P4EST_MAXLEVEL
 
static void(&) transfer_fixed (const types< 2 >::gloidx *dest_gfq, const types< 2 >::gloidx *src_gfq, MPI_Comm mpicomm, int tag, void *dest_data, const void *src_data, std::size_t data_size)
 
static types< 2 >::transfer_context *(&) transfer_fixed_begin (const types< 2 >::gloidx *dest_gfq, const types< 2 >::gloidx *src_gfq, MPI_Comm mpicomm, int tag, void *dest_data, const void *src_data, std::size_t data_size)
 
static void(&) transfer_fixed_end (types< 2 >::transfer_context *tc)
 
static void(&) transfer_custom (const types< 2 >::gloidx *dest_gfq, const types< 2 >::gloidx *src_gfq, MPI_Comm mpicomm, int tag, void *dest_data, const int *dest_sizes, const void *src_data, const int *src_sizes)
 
static types< 2 >::transfer_context *(&) transfer_custom_begin (const types< 2 >::gloidx *dest_gfq, const types< 2 >::gloidx *src_gfq, MPI_Comm mpicomm, int tag, void *dest_data, const int *dest_sizes, const void *src_data, const int *src_sizes)
 
static void(&) transfer_custom_end (types< 2 >::transfer_context *tc)
 
static void(&) quadrant_coord_to_vertex (types< 2 >::connectivity *connectivity, types< 2 >::topidx treeid, types< 2 >::quadrant_coord x, types< 2 >::quadrant_coord y, double vxyz[3])
 

Detailed Description

Definition at line 134 of file p4est_wrappers.h.

Member Function Documentation

◆ iterate()

template<int spacedim>
static void internal::p4est::functions< 2 >::iterate ( ::internal::p4est::types< 2 >::forest *  parallel_forest,
::internal::p4est::types< 2 >::ghost *  parallel_ghost,
void *  user_data 
)
static

Member Data Documentation

◆ quadrant_compare

int(&) internal::p4est::functions< 2 >::quadrant_compare(const void *v1, const void *v2)
static

Definition at line 136 of file p4est_wrappers.h.

◆ quadrant_childrenv

void(&) internal::p4est::functions< 2 >::quadrant_childrenv(const types< 2 >::quadrant *q, types< 2 >::quadrant c[])
static

Definition at line 138 of file p4est_wrappers.h.

◆ quadrant_overlaps_tree

int(&) internal::p4est::functions< 2 >::quadrant_overlaps_tree(types< 2 >::tree *tree, const types< 2 >::quadrant *q)
static

Definition at line 141 of file p4est_wrappers.h.

◆ quadrant_set_morton

void(&) internal::p4est::functions< 2 >::quadrant_set_morton(types< 2 >::quadrant *quadrant, int level, std::uint64_t id)
static

Definition at line 144 of file p4est_wrappers.h.

◆ quadrant_is_equal

int(&) internal::p4est::functions< 2 >::quadrant_is_equal(const types< 2 >::quadrant *q1, const types< 2 >::quadrant *q2)
static

Definition at line 148 of file p4est_wrappers.h.

◆ quadrant_is_sibling

int(&) internal::p4est::functions< 2 >::quadrant_is_sibling(const types< 2 >::quadrant *q1, const types< 2 >::quadrant *q2)
static

Definition at line 151 of file p4est_wrappers.h.

◆ quadrant_is_ancestor

int(&) internal::p4est::functions< 2 >::quadrant_is_ancestor(const types< 2 >::quadrant *q1, const types< 2 >::quadrant *q2)
static

Definition at line 154 of file p4est_wrappers.h.

◆ quadrant_ancestor_id

int(&) internal::p4est::functions< 2 >::quadrant_ancestor_id(const types< 2 >::quadrant *q, int level)
static

Definition at line 157 of file p4est_wrappers.h.

◆ comm_find_owner

int(&) internal::p4est::functions< 2 >::comm_find_owner(types< 2 >::forest *p4est, const types< 2 >::locidx which_tree, const types< 2 >::quadrant *q, const int guess)
static

Definition at line 160 of file p4est_wrappers.h.

◆ connectivity_new

types< 2 >::connectivity *(&) internal::p4est::functions< 2 >::connectivity_new(types< 2 >::topidx num_vertices, types< 2 >::topidx num_trees, types< 2 >::topidx num_corners, types< 2 >::topidx num_vtt)
static

Definition at line 165 of file p4est_wrappers.h.

◆ connectivity_new_copy

types< 2 >::connectivity *(&) internal::p4est::functions< 2 >::connectivity_new_copy(types< 2 >::topidx num_vertices, types< 2 >::topidx num_trees, types< 2 >::topidx num_corners, const double *vertices, const types< 2 >::topidx *ttv, const types< 2 >::topidx *ttt, const int8_t *ttf, const types< 2 >::topidx *ttc, const types< 2 >::topidx *coff, const types< 2 >::topidx *ctt, const int8_t *ctc)
static

Definition at line 171 of file p4est_wrappers.h.

◆ connectivity_join_faces

void(&) internal::p4est::functions< 2 >::connectivity_join_faces(types< 2 >::connectivity *conn, types< 2 >::topidx tree_left, types< 2 >::topidx tree_right, int face_left, int face_right, int orientation)
static

Definition at line 184 of file p4est_wrappers.h.

◆ connectivity_destroy

void(&) internal::p4est::functions< 2 >::connectivity_destroy(p4est_connectivity_t *connectivity)
static

Definition at line 193 of file p4est_wrappers.h.

◆ new_forest

types< 2 >::forest *(&) internal::p4est::functions< 2 >::new_forest(MPI_Comm mpicomm, types< 2 >::connectivity *connectivity, types< 2 >::locidx min_quadrants, int min_level, int fill_uniform, std::size_t data_size, p4est_init_t init_fn, void *user_pointer)
static

Definition at line 195 of file p4est_wrappers.h.

◆ copy_forest

types< 2 >::forest *(&) internal::p4est::functions< 2 >::copy_forest(types< 2 >::forest *input, int copy_data)
static

Definition at line 205 of file p4est_wrappers.h.

◆ destroy

void(&) internal::p4est::functions< 2 >::destroy(types< 2 >::forest *p4est)
static

Definition at line 208 of file p4est_wrappers.h.

◆ refine

void(&) internal::p4est::functions< 2 >::refine(types< 2 >::forest *p4est, int refine_recursive, p4est_refine_t refine_fn, p4est_init_t init_fn)
static

Definition at line 210 of file p4est_wrappers.h.

◆ coarsen

void(&) internal::p4est::functions< 2 >::coarsen(types< 2 >::forest *p4est, int coarsen_recursive, p4est_coarsen_t coarsen_fn, p4est_init_t init_fn)
static

Definition at line 215 of file p4est_wrappers.h.

◆ balance

void(&) internal::p4est::functions< 2 >::balance(types< 2 >::forest *p4est, types< 2 >::balance_type btype, p4est_init_t init_fn)
static

Definition at line 220 of file p4est_wrappers.h.

◆ partition

types< 2 >::gloidx(&) internal::p4est::functions< 2 >::partition(types< 2 >::forest *p4est, int partition_for_coarsening, p4est_weight_t weight_fn)
static

Definition at line 224 of file p4est_wrappers.h.

◆ save

void(&) internal::p4est::functions< 2 >::save(const char *filename, types< 2 >::forest *p4est, int save_data)
static

Definition at line 228 of file p4est_wrappers.h.

◆ load_ext

types< 2 >::forest *(&) internal::p4est::functions< 2 >::load_ext(const char *filename, MPI_Comm mpicomm, std::size_t data_size, int load_data, int autopartition, int broadcasthead, void *user_pointer, types< 2 >::connectivity **p4est)
static

Definition at line 232 of file p4est_wrappers.h.

◆ connectivity_save

int(&) internal::p4est::functions< 2 >::connectivity_save(const char *filename, types< 2 >::connectivity *connectivity)
static

Definition at line 241 of file p4est_wrappers.h.

◆ connectivity_is_valid

int(&) internal::p4est::functions< 2 >::connectivity_is_valid(types< 2 >::connectivity *connectivity)
static

Definition at line 244 of file p4est_wrappers.h.

◆ connectivity_load

types< 2 >::connectivity *(&) internal::p4est::functions< 2 >::connectivity_load(const char *filename, std::size_t *length)
static

Definition at line 246 of file p4est_wrappers.h.

◆ checksum

unsigned int(&) internal::p4est::functions< 2 >::checksum(types< 2 >::forest *p4est)
static

Definition at line 249 of file p4est_wrappers.h.

◆ vtk_write_file

void(&) internal::p4est::functions< 2 >::vtk_write_file(types< 2 >::forest *p4est, p4est_geometry_t *, const char *baseName)
static

Definition at line 251 of file p4est_wrappers.h.

◆ ghost_new

types< 2 >::ghost *(&) internal::p4est::functions< 2 >::ghost_new(types< 2 >::forest *p4est, types< 2 >::balance_type btype)
static

Definition at line 255 of file p4est_wrappers.h.

◆ ghost_destroy

void(&) internal::p4est::functions< 2 >::ghost_destroy(types< 2 >::ghost *ghost)
static

Definition at line 258 of file p4est_wrappers.h.

◆ reset_data

void(&) internal::p4est::functions< 2 >::reset_data(types< 2 >::forest *p4est, std::size_t data_size, p4est_init_t init_fn, void *user_pointer)
static

Definition at line 260 of file p4est_wrappers.h.

◆ forest_memory_used

std::size_t(&) internal::p4est::functions< 2 >::forest_memory_used(types< 2 >::forest *p4est)
static

Definition at line 265 of file p4est_wrappers.h.

◆ connectivity_memory_used

std::size_t(&) internal::p4est::functions< 2 >::connectivity_memory_used(types< 2 >::connectivity *p4est)
static

Definition at line 267 of file p4est_wrappers.h.

◆ max_level

constexpr unsigned int internal::p4est::functions< 2 >::max_level = P4EST_MAXLEVEL
staticconstexpr

Definition at line 276 of file p4est_wrappers.h.

◆ transfer_fixed

void(&) internal::p4est::functions< 2 >::transfer_fixed(const types< 2 >::gloidx *dest_gfq, const types< 2 >::gloidx *src_gfq, MPI_Comm mpicomm, int tag, void *dest_data, const void *src_data, std::size_t data_size)
static

Definition at line 278 of file p4est_wrappers.h.

◆ transfer_fixed_begin

types< 2 >::transfer_context *(&) internal::p4est::functions< 2 >::transfer_fixed_begin(const types< 2 >::gloidx *dest_gfq, const types< 2 >::gloidx *src_gfq, MPI_Comm mpicomm, int tag, void *dest_data, const void *src_data, std::size_t data_size)
static

Definition at line 286 of file p4est_wrappers.h.

◆ transfer_fixed_end

void(&) internal::p4est::functions< 2 >::transfer_fixed_end(types< 2 >::transfer_context *tc)
static

Definition at line 295 of file p4est_wrappers.h.

◆ transfer_custom

void(&) internal::p4est::functions< 2 >::transfer_custom(const types< 2 >::gloidx *dest_gfq, const types< 2 >::gloidx *src_gfq, MPI_Comm mpicomm, int tag, void *dest_data, const int *dest_sizes, const void *src_data, const int *src_sizes)
static

Definition at line 297 of file p4est_wrappers.h.

◆ transfer_custom_begin

types< 2 >::transfer_context *(&) internal::p4est::functions< 2 >::transfer_custom_begin(const types< 2 >::gloidx *dest_gfq, const types< 2 >::gloidx *src_gfq, MPI_Comm mpicomm, int tag, void *dest_data, const int *dest_sizes, const void *src_data, const int *src_sizes)
static

Definition at line 306 of file p4est_wrappers.h.

◆ transfer_custom_end

void(&) internal::p4est::functions< 2 >::transfer_custom_end(types< 2 >::transfer_context *tc)
static

Definition at line 316 of file p4est_wrappers.h.

◆ quadrant_coord_to_vertex

void(&) internal::p4est::functions< 2 >::quadrant_coord_to_vertex(types< 2 >::connectivity *connectivity, types< 2 >::topidx treeid, types< 2 >::quadrant_coord x, types< 2 >::quadrant_coord y, double vxyz[3])
static

Definition at line 327 of file p4est_wrappers.h.


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