refine_and_coarsen_fixed_number(
parallel::distributed::Triangulation<dim, spacedim> &tria,
const dealii::Vector<Number> & criteria,
- const double top_fraction_of_cells,
- const double bottom_fraction_of_cells,
- const unsigned int max_n_cells =
- std::numeric_limits<unsigned int>::max());
+ const double top_fraction_of_cells,
+ const double bottom_fraction_of_cells,
+ const types::global_dof_index max_n_cells =
+ std::numeric_limits<types::global_dof_index>::max());
/**
* Like dealii::GridRefinement::refine_and_coarsen_fixed_fraction, but
template <int dim>
std::pair<double, double>
adjust_refine_and_coarsen_number_fraction(
- const unsigned int current_n_cells,
- const unsigned int max_n_cells,
- const double top_fraction_of_cells,
- const double bottom_fraction_of_cells);
+ const types::global_dof_index current_n_cells,
+ const types::global_dof_index max_n_cells,
+ const double top_fraction_of_cells,
+ const double bottom_fraction_of_cells);
/**
* This function provides a strategy to mark cells for refinement and
refine_and_coarsen_fixed_number(
parallel::distributed::Triangulation<dim, spacedim> &tria,
const dealii::Vector<Number> & criteria,
- const double top_fraction_of_cells,
- const double bottom_fraction_of_cells,
- const unsigned int max_n_cells)
+ const double top_fraction_of_cells,
+ const double bottom_fraction_of_cells,
+ const types::global_dof_index max_n_cells)
{
Assert(criteria.size() == tria.n_active_cells(),
ExcDimensionMismatch(criteria.size(), tria.n_active_cells()));
const dealii::Vector<S> &,
const double,
const double,
- const unsigned int);
+ const types::global_dof_index);
template void
refine_and_coarsen_fixed_fraction<deal_II_dimension,
const dealii::Vector<S> &,
const double,
const double,
- const unsigned int);
+ const types::global_dof_index);
template void refine_and_coarsen_fixed_fraction<deal_II_dimension - 1,
S,
template <int dim>
std::pair<double, double>
GridRefinement::adjust_refine_and_coarsen_number_fraction(
- const unsigned int current_n_cells,
- const unsigned int max_n_cells,
- const double top_fraction,
- const double bottom_fraction)
+ const types::global_dof_index current_n_cells,
+ const types::global_dof_index max_n_cells,
+ const double top_fraction,
+ const double bottom_fraction)
{
Assert(top_fraction >= 0, ExcInvalidParameterValue());
Assert(top_fraction <= 1, ExcInvalidParameterValue());
// again, this is true for isotropically
// refined cells. we take this as an
// approximation of a mixed refinement.
- else if (static_cast<unsigned int>(
+ else if (static_cast<types::global_dof_index>(
current_n_cells + refine_cells * cell_increase_on_refine -
coarsen_cells * cell_decrease_on_coarsen) > max_n_cells)
{
for (deal_II_dimension : DIMENSIONS)
{
- template std::pair<double, double> GridRefinement::
- adjust_refine_and_coarsen_number_fraction<deal_II_dimension>(
- const unsigned int, const unsigned int, const double, const double);
+ template std::pair<double, double>
+ GridRefinement::adjust_refine_and_coarsen_number_fraction<
+ deal_II_dimension>(const types::global_dof_index,
+ const types::global_dof_index,
+ const double,
+ const double);
}