* @deprecated Use the more clearly named function locally_owned_size()
* instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
unsigned int
local_size() const;
/**
* Construct a thread object with a function object.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
Thread(const std::function<RT()> &function)
: thread_descriptor(new internal::ThreadDescriptor<RT>())
{
* this way, except for assigning it a thread object that holds data
* created by the new_thread() functions.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
Thread() = default;
/**
* Copy constructor.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
Thread(const Thread<RT> &t)
: thread_descriptor(t.thread_descriptor)
{}
* @deprecated Use TaskGroup instead.
*/
template <typename RT = void>
- class DEAL_II_DEPRECATED_EARLY ThreadGroup
+ class DEAL_II_DEPRECATED ThreadGroup
{
public:
/**
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
template <int dim, int spacedim>
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
extract_boundary_dofs(const DoFHandler<dim, spacedim> & dof_handler,
const ComponentMask & component_mask,
std::vector<bool> & selected_dofs,
* @deprecated Use the previous function instead.
*/
template <int dim, int spacedim>
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
extract_boundary_dofs(const DoFHandler<dim, spacedim> & dof_handler,
const ComponentMask & component_mask,
IndexSet & selected_dofs,
* @deprecated Use the types defined in the surrounding class instead.
*/
template <typename Number>
- struct DEAL_II_DEPRECATED_EARLY OutputType
+ struct DEAL_II_DEPRECATED OutputType
{
/**
* An alias for the data type of the product of a @p Number and the
* @deprecated Use the types defined in the surrounding class instead.
*/
template <typename Number>
- struct DEAL_II_DEPRECATED_EARLY OutputType
+ struct DEAL_II_DEPRECATED OutputType
{
/**
* An alias for the data type of the product of a @p Number and the
* @deprecated Use the types defined in the surrounding class instead.
*/
template <typename Number>
- struct DEAL_II_DEPRECATED_EARLY OutputType
+ struct DEAL_II_DEPRECATED OutputType
{
/**
* An alias for the data type of the product of a @p Number and the
* @deprecated Use the types defined in the surrounding class instead.
*/
template <typename Number>
- struct DEAL_II_DEPRECATED_EARLY OutputType
+ struct DEAL_II_DEPRECATED OutputType
{
/**
* An alias for the data type of the product of a @p Number and the
*
* @deprecated Use initialize() version above instead.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
initialize(const Triangulation<dim, spacedim> & triangulation,
const MappingQGeneric<dim, spacedim> &mapping);
* this class. Usage of the old-style numbering is deprecated.
*/
template <int dim, int spacedim = dim>
-class DEAL_II_DEPRECATED_EARLY GridReordering
+class DEAL_II_DEPRECATED GridReordering
{
public:
/**
*
* @deprecated Use GridTools::consistently_order_cells() instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
static void
reorder_cells(std::vector<CellData<dim>> &original_cells,
const bool use_new_style_ordering = false);
*
* @deprecated Use GridTools::invert_all_negative_measure_cells() instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
static void
invert_all_cells_of_negative_grid(
const std::vector<Point<spacedim>> &all_vertices,
* @deprecated Use the more general function which takes an ArrayView instead.
*/
template <int dim>
- DEAL_II_DEPRECATED_EARLY double
+ DEAL_II_DEPRECATED double
cell_measure(
const std::vector<Point<dim>> &all_vertices,
const unsigned int (&vertex_indices)[GeometryInfo<dim>::vertices_per_cell]);
* Throw an error, since this function is not useful in the context of this
* class.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
virtual void
create_triangulation_compatibility(
const std::vector<Point<spacedim>> &vertices,
* @note This function internally calls create_triangulation and therefore
* can throw the same exception as the other function.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
virtual void
create_triangulation_compatibility(
const std::vector<Point<spacedim>> &vertices,
/**
* @deprecated Use n_active_descendants() instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
unsigned int
number_of_children() const;
/**
* @deprecated Use n_active_descendants() instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
static unsigned int
number_of_children();
/**
* @deprecated Use n_active_descendants() instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
static unsigned int
number_of_children();
* originally defined in the LinearAlgebra namespace but is now used for more
* general purposes.
*/
- using CommunicationPatternBase DEAL_II_DEPRECATED_EARLY =
+ using CommunicationPatternBase DEAL_II_DEPRECATED =
Utilities::MPI::CommunicationPatternBase;
} // end of namespace LinearAlgebra
*
* @deprecated Use zero_out_ghost_values() instead.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
zero_out_ghosts() const;
*
* @deprecated Use zero_out_ghost_values() instead.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
zero_out_ghosts() const;
/**
*
* @deprecated Use locally_owned_size() instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
size_type
local_size() const;
* Alias for backwards-compatibility.
* @deprecated Use PETScWrappers::PreconditionBase instead.
*/
- using PreconditionerBase DEAL_II_DEPRECATED_EARLY = PreconditionBase;
+ using PreconditionerBase DEAL_II_DEPRECATED = PreconditionBase;
} // namespace PETScWrappers
*
* @deprecated use locally_owned_size() instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
size_type
local_size() const;
*
* @deprecated use locally_owned_size() instead.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
size_type
n_elements() const;
*
* @deprecated This function is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
size_type
local_size() const;
* specifying the tolerance for the resolution. A part from the tolerance
* only `rhs` is provided and `dst` needs to be returned.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
std::function<int(const VectorType &rhs, VectorType &dst)>
solve_jacobian_system;
* AdditionalData::maximum_newton_step variable to one, indicating
* that the Jacobian should be re-computed in every iteration.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
std::function<int(const VectorType &ycur,
const VectorType &fcur,
const VectorType &rhs,