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\}}\)
grid_refinement.h
Go to the documentation of this file.
1 // ---------------------------------------------------------------------
2 //
3 // Copyright (C) 2009 - 2020 by the deal.II authors
4 //
5 // This file is part of the deal.II library.
6 //
7 // The deal.II library is free software; you can use it, redistribute
8 // it, and/or modify it under the terms of the GNU Lesser General
9 // Public License as published by the Free Software Foundation; either
10 // version 2.1 of the License, or (at your option) any later version.
11 // The full text of the license can be found in the file LICENSE.md at
12 // the top level directory of deal.II.
13 //
14 // ---------------------------------------------------------------------
15 
16 #ifndef dealii_distributed_grid_refinement_h
17 #define dealii_distributed_grid_refinement_h
18 
19 
20 #include <deal.II/base/config.h>
21 
23 
25 
26 #include <limits>
27 #include <vector>
28 
30 
31 namespace internal
32 {
33  namespace parallel
34  {
35  namespace distributed
36  {
37  namespace GridRefinement
38  {
44  template <typename number>
45  std::pair<number, number>
47  const ::Vector<number> &criteria,
48  MPI_Comm mpi_communicator);
49 
50  namespace RefineAndCoarsenFixedNumber
51  {
56  template <typename number>
57  number
58  compute_threshold(const ::Vector<number> & criteria,
59  const std::pair<double, double> &global_min_and_max,
60  const types::global_cell_index n_target_cells,
61  MPI_Comm mpi_communicator);
62  } // namespace RefineAndCoarsenFixedNumber
63 
64  namespace RefineAndCoarsenFixedFraction
65  {
72  template <typename number>
73  number
74  compute_threshold(const ::Vector<number> & criteria,
75  const std::pair<double, double> &global_min_and_max,
76  const double target_error,
77  MPI_Comm mpi_communicator);
78  } // namespace RefineAndCoarsenFixedFraction
79  } // namespace GridRefinement
80  } // namespace distributed
81  } // namespace parallel
82 } // namespace internal
83 
84 
85 
86 namespace parallel
87 {
88  namespace distributed
89  {
105  namespace GridRefinement
106  {
129  template <int dim, typename Number, int spacedim>
130  void
133  const ::Vector<Number> & criteria,
134  const double top_fraction_of_cells,
135  const double bottom_fraction_of_cells,
136  const types::global_cell_index max_n_cells =
138 
162  template <int dim, typename Number, int spacedim>
163  void
166  const ::Vector<Number> & criteria,
167  const double top_fraction_of_error,
168  const double bottom_fraction_of_error);
169  } // namespace GridRefinement
170  } // namespace distributed
171 } // namespace parallel
172 
173 
175 
176 #endif // dealii_distributed_grid_refinement_h
GridRefinement
Definition: grid_refinement.h:54
parallel::distributed::GridRefinement::refine_and_coarsen_fixed_number
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())
Definition: grid_refinement.cc:432
parallel::distributed::GridRefinement::refine_and_coarsen_fixed_fraction
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)
Definition: grid_refinement.cc:504
MPI_Comm
internal::parallel::distributed::GridRefinement::compute_global_min_and_max_at_root
std::pair< number, number > compute_global_min_and_max_at_root(const ::Vector< number > &criteria, MPI_Comm mpi_communicator)
Definition: grid_refinement.cc:203
types::global_cell_index
unsigned int global_cell_index
Definition: types.h:105
DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_OPEN
Definition: config.h:358
internal::parallel::distributed::GridRefinement::RefineAndCoarsenFixedNumber::compute_threshold
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)
Definition: grid_refinement.cc:235
parallel::distributed::Triangulation
Definition: tria.h:242
internal::parallel::distributed::GridRefinement::RefineAndCoarsenFixedFraction::compute_threshold
number compute_threshold(const ::Vector< number > &criteria, const std::pair< double, double > &global_min_and_max, const double target_error, MPI_Comm mpi_communicator)
Definition: grid_refinement.cc:318
exceptions.h
tria.h
config.h
internal
Definition: aligned_vector.h:369
DEAL_II_NAMESPACE_CLOSE
#define DEAL_II_NAMESPACE_CLOSE
Definition: config.h:359
parallel
Definition: distributed.h:416
Utilities::MPI::max
T max(const T &t, const MPI_Comm &mpi_communicator)