16#ifndef dealii_distributed_grid_refinement_h
17#define dealii_distributed_grid_refinement_h
46 template <
typename number>
47 std::pair<number, number>
49 const ::Vector<number> &criteria,
52 namespace RefineAndCoarsenFixedNumber
58 template <
typename number>
61 const std::pair<double, double> &global_min_and_max,
66 namespace RefineAndCoarsenFixedFraction
74 template <
typename number>
77 const std::pair<double, double> &global_min_and_max,
78 const double target_error,
152 template <
int dim,
typename Number,
int spacedim>
156 const ::Vector<Number> & criteria,
157 const double top_fraction_of_cells,
158 const double bottom_fraction_of_cells,
160 std::numeric_limits<types::global_cell_index>::max());
205 template <
int dim,
typename Number,
int spacedim>
209 const ::Vector<Number> & criteria,
210 const double top_fraction_of_error,
211 const double bottom_fraction_of_error,
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
number compute_threshold(const ::Vector< number > &criteria, const std::pair< double, double > &global_min_and_max, const double target_error, const MPI_Comm &mpi_communicator)
number compute_threshold(const ::Vector< number > &criteria, const std::pair< double, double > &global_min_and_max, const types::global_cell_index n_target_cells, const MPI_Comm &mpi_communicator)
std::pair< number, number > compute_global_min_and_max_at_root(const ::Vector< number > &criteria, const MPI_Comm &mpi_communicator)
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, const VectorTools::NormType norm_type=VectorTools::NormType::L1_norm)
unsigned int global_cell_index
const ::Triangulation< dim, spacedim > & tria