|
Reference documentation for deal.II version 9.2.0
|
\(\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\}}\)
Go to the documentation of this file.
16 #ifndef dealii_distributed_grid_refinement_h
17 #define dealii_distributed_grid_refinement_h
44 template <
typename number>
45 std::pair<number, number>
47 const ::Vector<number> &criteria,
50 namespace RefineAndCoarsenFixedNumber
56 template <
typename number>
59 const std::pair<double, double> &global_min_and_max,
64 namespace RefineAndCoarsenFixedFraction
72 template <
typename number>
75 const std::pair<double, double> &global_min_and_max,
76 const double target_error,
129 template <
int dim,
typename Number,
int spacedim>
133 const ::Vector<Number> & criteria,
134 const double top_fraction_of_cells,
135 const double bottom_fraction_of_cells,
162 template <
int dim,
typename Number,
int spacedim>
166 const ::Vector<Number> & criteria,
167 const double top_fraction_of_error,
168 const double bottom_fraction_of_error);
176 #endif // dealii_distributed_grid_refinement_h
void refine_and_coarsen_fixed_number(parallel::distributed::Triangulation< dim, spacedim > &tria, const ::Vector< Number > &criteria, const double top_fraction_of_cells, const double bottom_fraction_of_cells, const types::global_cell_index max_n_cells=std::numeric_limits< types::global_cell_index >::max())
void refine_and_coarsen_fixed_fraction(parallel::distributed::Triangulation< dim, spacedim > &tria, const ::Vector< Number > &criteria, const double top_fraction_of_error, const double bottom_fraction_of_error)
std::pair< number, number > compute_global_min_and_max_at_root(const ::Vector< number > &criteria, MPI_Comm mpi_communicator)
unsigned int global_cell_index
#define DEAL_II_NAMESPACE_OPEN
number compute_threshold(const ::Vector< number > &criteria, const std::pair< double, double > &global_min_and_max, const types::global_cell_index n_target_cells, MPI_Comm mpi_communicator)
number compute_threshold(const ::Vector< number > &criteria, const std::pair< double, double > &global_min_and_max, const double target_error, MPI_Comm mpi_communicator)
#define DEAL_II_NAMESPACE_CLOSE
T max(const T &t, const MPI_Comm &mpi_communicator)