--- /dev/null
+Removed: The deprecated versions of DoFTools::count_dofs_per_component()
+and DoFTools::count_dofs_per_block() have been removed.
+<br>
+(Daniel Arndt, 2021/06/01)
const bool vector_valued_once = false,
const std::vector<unsigned int> &target_component = {});
- /**
- * @deprecated A version of the previous function that returns its
- * information through the non-`const` second argument.
- */
- template <int dim, int spacedim>
- DEAL_II_DEPRECATED void
- count_dofs_per_component(
- const DoFHandler<dim, spacedim> & dof_handler,
- std::vector<types::global_dof_index> &dofs_per_component,
- const bool vector_valued_once = false,
- const std::vector<unsigned int> & target_component = {});
-
/**
* Count the degrees of freedom in each block. This function is similar to
* count_dofs_per_component(), with the difference that the counting is done
const std::vector<unsigned int> &target_block =
std::vector<unsigned int>());
- /**
- * @deprecated A version of the previous function that returns its
- * information through the non-`const` second argument.
- */
- template <int dim, int spacedim>
- DEAL_II_DEPRECATED void
- count_dofs_per_block(const DoFHandler<dim, spacedim> & dof,
- std::vector<types::global_dof_index> &dofs_per_block,
- const std::vector<unsigned int> & target_block =
- std::vector<unsigned int>());
-
/**
* For each active cell of a DoFHandler, extract the active finite element
* index and fill the vector given as second argument. This vector is assumed
- // deprecated function
- template <int dim, int spacedim>
- void
- count_dofs_per_component(
- const DoFHandler<dim, spacedim> & dof_handler,
- std::vector<types::global_dof_index> &dofs_per_component,
- const bool only_once,
- const std::vector<unsigned int> & target_component)
- {
- dofs_per_component =
- count_dofs_per_fe_component(dof_handler, only_once, target_component);
- }
-
-
-
template <int dim, int spacedim>
std::vector<types::global_dof_index>
count_dofs_per_fe_component(
- // deprecated function
- template <int dim, int spacedim>
- void
- count_dofs_per_block(const DoFHandler<dim, spacedim> & dof_handler,
- std::vector<types::global_dof_index> &dofs_per_block,
- const std::vector<unsigned int> & target_block)
- {
- dofs_per_block = count_dofs_per_fe_block(dof_handler, target_block);
- }
-
-
-
template <int dim, int spacedim>
std::vector<types::global_dof_index>
count_dofs_per_fe_block(const DoFHandler<dim, spacedim> &dof_handler,
& dof_handler,
const ComponentMask &components);
- // deprecated versions of the count_dofs_per_*() functions
- template void
- count_dofs_per_component<deal_II_dimension, deal_II_space_dimension>(
- const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
- std::vector<types::global_dof_index> &,
- const bool,
- const std::vector<unsigned int> &);
-
- template void
- count_dofs_per_block<deal_II_dimension, deal_II_space_dimension>(
- const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
- std::vector<types::global_dof_index> &,
- const std::vector<unsigned int> &);
-
- // new versions of the count_dofs_per_*() functions
template std::vector<types::global_dof_index>
count_dofs_per_fe_component<deal_II_dimension, deal_II_space_dimension>(
const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
dof_handler_ref.distribute_dofs(fe);
DoFRenumbering::Cuthill_McKee(dof_handler_ref);
DoFRenumbering::component_wise(dof_handler_ref, block_component);
- DoFTools::count_dofs_per_block(dof_handler_ref,
- dofs_per_block,
- block_component);
+ dofs_per_block =
+ DoFTools::count_dofs_per_block(dof_handler_ref, block_component);
std::cout << "Triangulation:"
<< "\n\t Number of active cells: "
<< triangulation.n_active_cells()