<li> Removed: This release removes a number of functions that have long
been deprecated and that were previously already marked as
deprecated (i.e., they would have yielded warnings by the compiler whenever
- you tried to use them). Specifically, these are:
+ you tried to use them). In almost all cases, there is a function with same
+ name but different argument list that should be used instead.
+ Specifically, the removed functions are:
- TimeDependent::end_sweep (with an argument).
- PointValueHistory::mark_locations.
- The DataPostprocessor::compute_derived_quantities_scalar and
these two concepts (since we switched from the FunctionParser
library to the muparser library after the deal.II 8.1 release).
- DoFRenumbering::downstream_dg.
+ - DoFTools::count_dofs_per_component.
</ol>
<li> Removed: The config.h file no longer exports HAVE_* definitions.
const std::vector<unsigned int> &target_block
= std::vector<unsigned int>());
- /**
- * @deprecated See the previous function with the same name for a
- * description. This function exists for compatibility with older versions
- * only.
- */
- 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,
- std::vector<unsigned int> target_component) DEAL_II_DEPRECATED;
-
-
/**
* For each active cell of a DoFHandler or hp::DoFHandler, extract the
* active finite element index and fill the vector given as second argument.
- 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,
- std::vector<unsigned int> target_component)
- {
- count_dofs_per_component (dof_handler, dofs_per_component,
- false, target_component);
- }
-
-
-
template <class DH>
void
map_dof_to_boundary_indices (const DH &dof_handler,
std::vector<types::global_dof_index>&,
const std::vector<unsigned int> &);
-template
-void
-DoFTools::count_dofs_per_component<deal_II_dimension> (
- const DoFHandler<deal_II_dimension>&,
- std::vector<types::global_dof_index>&, std::vector<unsigned int>);
-
template
void
DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension> >