*
* @deprecated Use clear_elements () instead
*/
- void clear() DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ void clear();
/**
* Call @p clear on all objects stored by this object. This function
* @deprecated This function has been deprecated in favor of the C++11
* function <code>std::isnan</code>.
*/
- bool is_nan (const double x) DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ bool is_nan (const double x);
/**
* Return @p true if the given value is a finite floating point number, i.e.
* @deprecated This function is deprecated because, even though it only
* outputs information, it is not a <code>const</code> function.
*/
+ DEAL_II_DEPRECATED
void print_parameters_section (std::ostream &out,
const OutputStyle style,
const unsigned int indent_level,
- const bool include_top_level_elements = false) DEAL_II_DEPRECATED;
+ const bool include_top_level_elements = false);
/**
* Print parameters to a logstream. This function allows to print all
/**
* Return the MPI communicator underlying the partitioner object.
*/
- const MPI_Comm &get_communicator() const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const MPI_Comm &get_communicator() const;
/**
* Return the MPI communicator underlying the partitioner object.
* @deprecated Use the constructor with the appropriate number of arguments
* to initialize the @p N indices instead.
*/
+ DEAL_II_DEPRECATED
TableIndices (const unsigned int index0,
const unsigned int index1,
const unsigned int index2,
const unsigned int index5,
const unsigned int index6 = numbers::invalid_unsigned_int,
const unsigned int index7 = numbers::invalid_unsigned_int,
- const unsigned int index8 = numbers::invalid_unsigned_int) DEAL_II_DEPRECATED;
+ const unsigned int index8 = numbers::invalid_unsigned_int);
/**
* Read-only access the value of the <tt>i</tt>th index.
*
* @author Wolfgang Bangerth, 2003
*/
-template <typename T> struct constraint_and_return_value<true,T>
+template <typename T>
+struct DEAL_II_DEPRECATED constraint_and_return_value<true,T>
{
typedef T type;
-} DEAL_II_DEPRECATED;
+};
* @author Wolfgang Bangerth, 2006
*/
template <int N>
- struct int2type
- {} DEAL_II_DEPRECATED;
+ struct DEAL_II_DEPRECATED int2type
+ {};
/**
* @author Wolfgang Bangerth, 2009
*/
template <bool B>
- struct bool2type
- {} DEAL_II_DEPRECATED;
+ struct DEAL_II_DEPRECATED bool2type
+ {};
}
* instead of this class.
*/
template <typename T, typename U>
-struct types_are_equal : std::is_same<T,U>
-{} DEAL_II_DEPRECATED;
+struct DEAL_II_DEPRECATED types_are_equal : std::is_same<T,U>
+{};
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
Number double_contract (const Tensor<2, dim, Number> &src1,
- const Tensor<2, dim, Number> &src2) DEAL_II_DEPRECATED;
+ const Tensor<2, dim, Number> &src2);
/**
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void double_contract (Tensor<2,dim,Number> &dest,
const Tensor<4,dim,Number> &src1,
- const Tensor<2,dim,Number> &src2) DEAL_II_DEPRECATED;
+ const Tensor<2,dim,Number> &src2);
/**
* Contract a tensor of rank 2 with a tensor of rank 2. The contraction is
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void contract (Tensor<2,dim,Number> &dest,
const Tensor<2,dim,Number> &src1,
const unsigned int index1,
const Tensor<2,dim,Number> &src2,
- const unsigned int index3) DEAL_II_DEPRECATED;
+ const unsigned int index3);
/**
* Contract a tensor of rank 3 with a tensor of rank 1. The contraction is
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void contract (Tensor<2,dim,Number> &dest,
const Tensor<3,dim,Number> &src1,
const unsigned int index1,
- const Tensor<1,dim,Number> &src2) DEAL_II_DEPRECATED;
+ const Tensor<1,dim,Number> &src2);
/**
* Contract a tensor of rank 3 with a tensor of rank 2. The contraction is
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void contract (Tensor<3,dim,Number> &dest,
const Tensor<3,dim,Number> &src1,
const unsigned int index1,
const Tensor<2,dim,Number> &src2,
- const unsigned int index2) DEAL_II_DEPRECATED;
+ const unsigned int index2);
/**
* Single contraction for tensors: contract the last index of a tensor @p src1
* @relates Tensor
*/
template <int rank_1, int rank_2, int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void contract (Tensor<rank_1 + rank_2 - 2, dim, Number> &dest,
const Tensor<rank_1, dim, Number> &src1,
- const Tensor<rank_2, dim, Number> &src2) DEAL_II_DEPRECATED;
+ const Tensor<rank_2, dim, Number> &src2);
/**
* Contract a tensor of rank 1 with a tensor of rank 1 and return the result.
* @relates Tensor
*/
template <int dim, typename Number, typename OtherNumber>
+DEAL_II_DEPRECATED
inline
typename ProductType<Number,OtherNumber>::type
contract (const Tensor<1,dim,Number> &src1,
- const Tensor<1,dim,OtherNumber> &src2) DEAL_II_DEPRECATED;
+ const Tensor<1,dim,OtherNumber> &src2);
/**
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void
cross_product (Tensor<1,dim,Number> &dst,
- const Tensor<1,dim,Number> &src) DEAL_II_DEPRECATED;
+ const Tensor<1,dim,Number> &src);
/**
* The cross product of 2 vectors in 3d.
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void
cross_product (Tensor<1,dim,Number> &dst,
const Tensor<1,dim,Number> &src1,
- const Tensor<1,dim,Number> &src2) DEAL_II_DEPRECATED;
+ const Tensor<1,dim,Number> &src2);
/**
* Form the outer product of two tensors.
* @relates Tensor
*/
template <int rank_1, int rank_2, int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void outer_product(Tensor<rank_1 + rank_2, dim, Number> &dst,
const Tensor<rank_1, dim, Number> &src1,
- const Tensor<rank_2, dim, Number> &src2) DEAL_II_DEPRECATED;
+ const Tensor<rank_2, dim, Number> &src2);
/**
* Multiply a Tensor<1,dim,Number> with a Number.
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void outer_product (Tensor<1,dim,Number> &dst,
const Number src1,
- const Tensor<1,dim,Number> &src2) DEAL_II_DEPRECATED;
+ const Tensor<1,dim,Number> &src2);
/**
* Multiply a Tensor<1,dim,Number> with a Number.
* @relates Tensor
*/
template <int dim, typename Number>
+DEAL_II_DEPRECATED
inline
void outer_product (Tensor<1,dim,Number> &dst,
const Tensor<1,dim,Number> src1,
- const Number src2) DEAL_II_DEPRECATED;
+ const Number src2);
/**
* @deprecated Do not use this function, evaluate the value manually.
* @relates Tensor
*/
template <int rank, typename Number>
+DEAL_II_DEPRECATED
inline
-Number determinant (const Tensor<rank,1,Number> &t) DEAL_II_DEPRECATED;
+Number determinant (const Tensor<rank,1,Number> &t);
/**
* @relates Tensor
*/
template <typename Number>
+DEAL_II_DEPRECATED
inline
-Number determinant (const Tensor<1,1,Number> &t) DEAL_II_DEPRECATED;
+Number determinant (const Tensor<1,1,Number> &t);
//@}
* @deprecated Use Timer::get_last_lap_wall_time_data() instead, which
* returns a reference to the same structure.
*/
- const Utilities::MPI::MinMaxAvg &get_data() const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Utilities::MPI::MinMaxAvg &get_data() const;
/**
* Return a reference to the data structure containing basic statistics on
* @deprecated Use Timer::get_accumulated_wall_time_data() instead, which
* returns a reference the same structure.
*/
- const Utilities::MPI::MinMaxAvg &get_total_data() const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Utilities::MPI::MinMaxAvg &get_total_data() const;
/**
* Return a reference to the data structure containing basic statistics on
* prints the same information.
*/
template <class StreamType>
- void print_data(StreamType &stream) const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ void print_data(StreamType &stream) const;
/**
* Print the data returned by Timer::get_last_lap_wall_time_data() to the
* prints the same information.
*/
template <class StreamType>
- void print_total_data(StreamType &stream) const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ void print_total_data(StreamType &stream) const;
/**
* Print the data returned by Timer::get_accumulated_wall_time_data() to the
*
* @deprecated Use cpu_time() instead.
*/
- double operator() () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ double operator() () const;
/**
* Return the current accumulated wall time (including the current lap, if
*
* @deprecated Use last_wall_time() instead.
*/
- double get_lap_time () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ double get_lap_time () const;
private:
/**
*
* @deprecated Use numbers::invalid_dof_index instead.
*/
- static const types::global_dof_index invalid_dof_index DEAL_II_DEPRECATED = numbers::invalid_dof_index;
+ DEAL_II_DEPRECATED
+ static const types::global_dof_index invalid_dof_index = numbers::invalid_dof_index;
/**
* The default index of the finite element to be used on a given cell. Since
*
* @deprecated Use the version without parameter instead.
*/
- virtual void distribute_mg_dofs (const FiniteElement<dim, spacedim> &fe) DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ virtual void distribute_mg_dofs (const FiniteElement<dim, spacedim> &fe);
/**
* Distribute level degrees of freedom on each level for geometric
* @relates DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
unsigned int
- max_dofs_per_cell (const DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ max_dofs_per_cell (const DoFHandler<dim,spacedim> &dh);
/**
* Maximal number of degrees of freedom on a cell.
* @relates hp::DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
unsigned int
- max_dofs_per_cell (const hp::DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ max_dofs_per_cell (const hp::DoFHandler<dim,spacedim> &dh);
/**
* @relates DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
unsigned int
- max_dofs_per_face (const DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ max_dofs_per_face (const DoFHandler<dim,spacedim> &dh);
/**
* Maximal number of degrees of freedom on a face.
* @relates hp::DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
unsigned int
- max_dofs_per_face (const hp::DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ max_dofs_per_face (const hp::DoFHandler<dim,spacedim> &dh);
/**
* Maximal number of degrees of freedom on a vertex.
* @relates DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
unsigned int
- max_dofs_per_vertex (const DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ max_dofs_per_vertex (const DoFHandler<dim,spacedim> &dh);
/**
* Maximal number of degrees of freedom on a vertex.
* @relates hp::DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
unsigned int
- max_dofs_per_vertex (const hp::DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ max_dofs_per_vertex (const hp::DoFHandler<dim,spacedim> &dh);
/**
* Number of vector components in the finite element object used by this
* @relates DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
unsigned int
- n_components (const DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ n_components (const DoFHandler<dim,spacedim> &dh);
/**
* Number of vector components in the finite element object used by this
* @relates hp::DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
unsigned int
- n_components (const hp::DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ n_components (const hp::DoFHandler<dim,spacedim> &dh);
/**
* Find out whether the first FiniteElement used by this DoFHandler is
* @relates DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
bool
- fe_is_primitive (const DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ fe_is_primitive (const DoFHandler<dim,spacedim> &dh);
/**
* Find out whether the first FiniteElement used by this DoFHandler is primitive
* @relates hp::DoFHandler
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
bool
- fe_is_primitive (const hp::DoFHandler<dim,spacedim> &dh) DEAL_II_DEPRECATED;
+ fe_is_primitive (const hp::DoFHandler<dim,spacedim> &dh);
/**
* @}
* function.
*/
template <typename DoFHandlerType>
+ DEAL_II_DEPRECATED
void
extract_locally_owned_dofs (const DoFHandlerType &dof_handler,
- IndexSet &dof_set) DEAL_II_DEPRECATED;
+ IndexSet &dof_set);
/**
* subset of generalized support points describing degrees of freedom for
* a given face. Don't use this function
*/
+ DEAL_II_DEPRECATED
const std::vector<Point<dim-1> > &
- get_generalized_face_support_points () const DEAL_II_DEPRECATED;
+ get_generalized_face_support_points () const;
/**
* Return whether a finite element has defined generalized support points on
* subset of generalized support points describing degrees of freedom for
* a given face. Don't use this function
*/
+ DEAL_II_DEPRECATED
bool
- has_generalized_face_support_points () const DEAL_II_DEPRECATED;
+ has_generalized_face_support_points () const;
/**
* For a given degree of freedom, return whether it is logically associated
* @deprecated Use get_fe_by_name() with two template parameters instead
*/
template <int dim>
+ DEAL_II_DEPRECATED
FiniteElement<dim,dim> *
- get_fe_from_name (const std::string &name) DEAL_II_DEPRECATED;
+ get_fe_from_name (const std::string &name);
/**
* @deprecated Use get_normal_vectors() instead, which returns the exact
* same thing.
*/
- const std::vector<Tensor<1,spacedim> > &get_all_normal_vectors () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const std::vector<Tensor<1,spacedim> > &get_all_normal_vectors () const;
/**
* Return the normal vectors at the quadrature points. For a face, these are
* <code>cell-@>face(f)</code> or <code>cell-@>line(l)</code>.
*/
template <typename MeshIteratorType>
+ DEAL_II_DEPRECATED
Quadrature<MeshIteratorType::AccessorType::space_dimension>
get_default_quadrature(const MeshIteratorType &iterator,
- const bool with_laplace = false) DEAL_II_DEPRECATED;
+ const bool with_laplace = false);
/**
* Given a general mesh iterator, construct arrays of quadrature points and
* @deprecated This member variable has been deprecated in favor of creating
* an independent FlatManifold.
*/
- static const StraightBoundary<dim,spacedim> straight_boundary DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ static const StraightBoundary<dim,spacedim> straight_boundary;
/**
* Declare some symbolic names for mesh smoothing algorithms. The meaning of
* @see
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
+ DEAL_II_DEPRECATED
void set_boundary (const types::manifold_id number,
- const Boundary<dim,spacedim> &boundary_object) DEAL_II_DEPRECATED;
+ const Boundary<dim,spacedim> &boundary_object);
/**
* @see
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
- void set_boundary (const types::manifold_id number) DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ void set_boundary (const types::manifold_id number);
/**
* Assign a manifold object to a certain part of the triangulation. If
* @see
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
- const Boundary<dim,spacedim> &get_boundary (const types::manifold_id number) const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Boundary<dim,spacedim> &get_boundary (const types::manifold_id number) const;
/**
* Return a constant reference to a Manifold object used for this
* Luca Heltai, 2014
*/
template <int dim, int spacedim=dim>
-class Boundary : public FlatManifold<dim, spacedim>
+class DEAL_II_DEPRECATED Boundary : public FlatManifold<dim, spacedim>
{
public:
* Mutex for protecting the points array.
*/
mutable Threads::Mutex mutex;
-} DEAL_II_DEPRECATED;
+};
* @author Wolfgang Bangerth, 1998, 2001, Ralf Hartmann, 2001
*/
template <int dim, int spacedim=dim>
-class StraightBoundary : public Boundary<dim,spacedim>
+class DEAL_II_DEPRECATED StraightBoundary : public Boundary<dim,spacedim>
{
public:
/**
Point<spacedim>
project_to_surface (const typename Triangulation<dim,spacedim>::hex_iterator &hex,
const Point<spacedim> &candidate) const;
-} DEAL_II_DEPRECATED;
+};
* @author Guido Kanschat, 2001, Wolfgang Bangerth, 2007
*/
template <int dim, int spacedim = dim>
-class CylinderBoundary : public StraightBoundary<dim,spacedim>
+class DEAL_II_DEPRECATED CylinderBoundary : public StraightBoundary<dim,spacedim>
{
public:
/**
* Given a number for the axis, return a vector that denotes this direction.
*/
static Point<spacedim> get_axis_vector (const unsigned int axis);
-} DEAL_II_DEPRECATED;
+};
* @author Markus Bürg, 2009
*/
template <int dim>
-class ConeBoundary : public StraightBoundary<dim>
+class DEAL_II_DEPRECATED ConeBoundary : public StraightBoundary<dim>
{
public:
/**
get_intermediate_points_between_points (const Point<dim> &p0,
const Point<dim> &p1,
std::vector<Point<dim> > &points) const;
-} DEAL_II_DEPRECATED;
+};
* @author Wolfgang Bangerth, 1998, Ralf Hartmann, 2001
*/
template <int dim, int spacedim=dim>
-class HyperBallBoundary : public StraightBoundary<dim,spacedim>
+class DEAL_II_DEPRECATED HyperBallBoundary : public StraightBoundary<dim,spacedim>
{
public:
/**
*/
void get_intermediate_points_between_points (const Point<spacedim> &p0, const Point<spacedim> &p1,
std::vector<Point<spacedim> > &points) const;
-} DEAL_II_DEPRECATED;
+};
* @author Wolfgang Bangerth, 1999, 2001
*/
template <int dim>
-class HalfHyperBallBoundary : public HyperBallBoundary<dim>
+class DEAL_II_DEPRECATED HalfHyperBallBoundary : public HyperBallBoundary<dim>
{
public:
/**
virtual void
get_normals_at_vertices (const typename Triangulation<dim>::face_iterator &face,
typename Boundary<dim>::FaceVertexNormals &face_vertex_normals) const;
-} DEAL_II_DEPRECATED;
+};
* @author Wolfgang Bangerth, 1999
*/
template <int dim>
-class HyperShellBoundary : public HyperBallBoundary<dim>
+class DEAL_II_DEPRECATED HyperShellBoundary : public HyperBallBoundary<dim>
{
public:
/**
* radius as argument. This radius will be ignored
*/
HyperShellBoundary (const Point<dim> ¢er = Point<dim>());
-} DEAL_II_DEPRECATED;
+};
* @author Wolfgang Bangerth, 2000, 2009
*/
template <int dim>
-class HalfHyperShellBoundary : public HyperShellBoundary<dim>
+class DEAL_II_DEPRECATED HalfHyperShellBoundary : public HyperShellBoundary<dim>
{
public:
/**
*/
const double inner_radius;
const double outer_radius;
-} DEAL_II_DEPRECATED;
+};
/**
* TorusManifold class.
*/
template <int dim, int spacedim>
-class TorusBoundary : public Boundary<dim,spacedim>
+class DEAL_II_DEPRECATED TorusBoundary : public Boundary<dim,spacedim>
{
public:
/**
*/
const double R;
const double r;
-} DEAL_II_DEPRECATED;
+};
*
* @deprecated Use numbers::invalid_dof_index instead.
*/
- static const types::global_dof_index invalid_dof_index DEAL_II_DEPRECATED = numbers::invalid_dof_index;
+ DEAL_II_DEPRECATED
+ static const types::global_dof_index invalid_dof_index = numbers::invalid_dof_index;
/**
* The default index of the finite element to be used on a given cell. For
*
* @deprecated Use get_fe_collection() instead.
*/
- const hp::FECollection<dim,spacedim> &get_fe () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const hp::FECollection<dim,spacedim> &get_fe () const;
/**
* Return a constant reference to the indexth finite element object that is
* @deprecated Use LocalIntegrators::GradDiv::cell_matrix() instead.
*/
template <int dim>
+ DEAL_II_DEPRECATED
void grad_div_matrix (
FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
- const double factor = 1.) DEAL_II_DEPRECATED;
+ const double factor = 1.);
template <int dim>
void grad_div_matrix (
* @deprecated Use LocalIntegrators::GradDiv::cell_residual() instead.
*/
template <int dim, typename number>
+ DEAL_II_DEPRECATED
void grad_div_residual (
Vector<number> &result,
const FEValuesBase<dim> &fetest,
const VectorSlice<const std::vector<std::vector<Tensor<1,dim> > > > &input,
- const double factor = 1.) DEAL_II_DEPRECATED;
+ const double factor = 1.);
template <int dim, typename number>
void grad_div_residual (
* @date 2000-2005, 2010
*/
template <typename number = double, typename BlockVectorType=BlockVector<number> >
-class BlockMatrixArray : public Subscriptor
+class DEAL_II_DEPRECATED BlockMatrixArray : public Subscriptor
{
public:
/**
* number of blocks per row.
*/
unsigned int block_cols;
-} DEAL_II_DEPRECATED;
+};
/*@}*/
* @author Guido Kanschat, 2001, 2005
*/
template <typename number = double, typename BlockVectorType = BlockVector<number> >
-class BlockTrianglePrecondition
+class DEAL_II_DEPRECATED BlockTrianglePrecondition
: private BlockMatrixArray<number,BlockVectorType>
{
public:
* Flag for backward insertion.
*/
bool backward;
-} DEAL_II_DEPRECATED;
+};
#ifndef DOXYGEN
*
* @deprecated Use the respective method with IndexSet arguments instead.
*/
- BlockSparsityPattern (const std::vector<Epetra_Map> ¶llel_partitioning) DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ BlockSparsityPattern (const std::vector<Epetra_Map> ¶llel_partitioning);
/**
* Initialize the pattern with an array of index sets that specifies both
*
* @deprecated Use the respective method with IndexSet arguments instead.
*/
- void reinit (const std::vector<Epetra_Map> ¶llel_partitioning) DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ void reinit (const std::vector<Epetra_Map> ¶llel_partitioning);
/**
* Resize the matrix to a square tensor product of matrices. See the
* constrained_linear_operator().
*/
template <typename VectorType>
-class FilteredMatrix : public Subscriptor
+class DEAL_II_DEPRECATED FilteredMatrix : public Subscriptor
{
public:
class const_iterator;
* the second parameter to @p true to use a faster algorithm. Note: This
* method is deprecated as matrix_is_symmetric parameter is no longer used.
*/
+ DEAL_II_DEPRECATED
void apply_constraints (VectorType &v,
- const bool matrix_is_symmetric) const DEAL_II_DEPRECATED;
+ const bool matrix_is_symmetric) const;
/**
* Apply the constraints to a right hand side vector. This needs to be done
* before starting to solve with the filtered matrix.
* FilteredMatrixBlock accesses pre_filter() and post_filter().
*/
friend class FilteredMatrixBlock<VectorType>;
-} DEAL_II_DEPRECATED;
+};
/*@}*/
/*---------------------- Inline functions -----------------------------------*/
*
* This function is deprecated.
*/
+ DEAL_II_DEPRECATED
void equ (const Number a, const BlockVector<Number> &u,
- const Number b, const BlockVector<Number> &v) DEAL_II_DEPRECATED;
+ const Number b, const BlockVector<Number> &v);
/**
* Scaling and multiple addition.
*
* This function is deprecated.
*/
+ DEAL_II_DEPRECATED
void sadd (const Number s,
const Number a,
const BlockVector<Number> &V,
const Number b,
- const BlockVector<Number> &W) DEAL_II_DEPRECATED;
+ const BlockVector<Number> &W);
/**
* Return whether the vector contains only elements with value zero.
* This function is deprecated. Use the interface through
* ReadWriteVector instead.
*/
+ DEAL_II_DEPRECATED
Vector<Number> &
- operator = (const PETScWrappers::MPI::Vector &petsc_vec) DEAL_II_DEPRECATED;
+ operator = (const PETScWrappers::MPI::Vector &petsc_vec);
#endif
#ifdef DEAL_II_WITH_TRILINOS
* This function is deprecated. Use the interface through
* ReadWriteVector instead.
*/
+ DEAL_II_DEPRECATED
Vector<Number> &
- operator = (const TrilinosWrappers::MPI::Vector &trilinos_vec) DEAL_II_DEPRECATED;
+ operator = (const TrilinosWrappers::MPI::Vector &trilinos_vec);
#endif
//@}
*
* This function is deprecated.
*/
+ DEAL_II_DEPRECATED
void sadd (const Number s,
const Number a,
const Vector<Number> &V,
const Number b,
- const Vector<Number> &W) DEAL_II_DEPRECATED;
+ const Vector<Number> &W);
/**
* Assignment <tt>*this = a*u + b*v</tt>.
*
* This function is deprecated.
*/
+ DEAL_II_DEPRECATED
void equ (const Number a, const Vector<Number> &u,
- const Number b, const Vector<Number> &v) DEAL_II_DEPRECATED;
+ const Number b, const Vector<Number> &v);
//@}
*
* This function is deprecated.
*/
- std::pair<size_type, size_type> local_range () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ std::pair<size_type, size_type> local_range () const;
/**
* Return true if the given global index is in the local range of this
*
* This function is deprecated.
*/
- bool in_local_range (const size_type global_index) const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ bool in_local_range (const size_type global_index) const;
/**
* Return the number of ghost elements present on the vector.
*
* This function is deprecated.
*/
- size_type n_ghost_entries () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ size_type n_ghost_entries () const;
/**
* Return an index set that describes which elements of this vector are
*
* This function is deprecated.
*/
- const IndexSet &ghost_elements() const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const IndexSet &ghost_elements() const;
/**
* Return whether the given global index is a ghost index on the
*
* This function is deprecated.
*/
- bool is_ghost_entry (const types::global_dof_index global_index) const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ bool is_ghost_entry (const types::global_dof_index global_index) const;
/**
* Make the @p Vector class a bit like the <tt>vector<></tt> class of
* @author Denis Davydov, 2015, 2017
*/
template <typename VectorType>
-class PArpackSolver : public Subscriptor
+class DEAL_II_DEPRECATED PArpackSolver : public Subscriptor
{
public:
/**
const MatrixType &B;
const double sigma;
- } DEAL_II_DEPRECATED;
+ };
/**
* Standardized data struct to pipe additional data to the solver, should it
* matrix.
* @deprecated Use the function with order of arguments reversed instead.
*/
+ DEAL_II_DEPRECATED
MatrixBase &add (const MatrixBase &other,
- const PetscScalar factor) DEAL_II_DEPRECATED;
+ const PetscScalar factor);
/**
* Matrix-vector multiplication: let <i>dst = M*src</i> with <i>M</i>
* @deprecated This constructor is deprecated: please use the
* constructor with a sparsity pattern argument instead.
*/
+ DEAL_II_DEPRECATED
SparseMatrix (const MPI_Comm &communicator,
const size_type m,
const size_type n,
const size_type local_columns,
const size_type n_nonzero_per_row,
const bool is_symmetric = false,
- const size_type n_offdiag_nonzero_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_offdiag_nonzero_per_row = 0);
/**
* Initialize a rectangular matrix with @p m rows and @p n columns. The
* @deprecated This constructor is deprecated: please use the
* constructor with a sparsity pattern argument instead.
*/
+ DEAL_II_DEPRECATED
SparseMatrix (const MPI_Comm &communicator,
const size_type m,
const size_type n,
const size_type local_columns,
const std::vector<size_type> &row_lengths,
const bool is_symmetric = false,
- const std::vector<size_type> &offdiag_row_lengths = std::vector<size_type>()) DEAL_II_DEPRECATED;
+ const std::vector<size_type> &offdiag_row_lengths = std::vector<size_type>());
/**
* Initialize using the given sparsity pattern with communication
* @deprecated This overload of <code>reinit</code> is deprecated:
* please use the overload with a sparsity pattern argument instead.
*/
+ DEAL_II_DEPRECATED
void reinit (const MPI_Comm &communicator,
const size_type m,
const size_type n,
const size_type local_columns,
const size_type n_nonzero_per_row,
const bool is_symmetric = false,
- const size_type n_offdiag_nonzero_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_offdiag_nonzero_per_row = 0);
/**
* Throw away the present matrix and generate one that has the same
* @deprecated This overload of <code>reinit</code> is deprecated:
* please use the overload with a sparsity pattern argument instead.
*/
+ DEAL_II_DEPRECATED
void reinit (const MPI_Comm &communicator,
const size_type m,
const size_type n,
const size_type local_columns,
const std::vector<size_type> &row_lengths,
const bool is_symmetric = false,
- const std::vector<size_type> &offdiag_row_lengths = std::vector<size_type>()) DEAL_II_DEPRECATED;
+ const std::vector<size_type> &offdiag_row_lengths = std::vector<size_type>());
/**
* Initialize using the given sparsity pattern with communication
* @deprecated This overload of <code>do_reinit</code> is deprecated:
* please use the overload with a sparsity pattern argument instead.
*/
+ DEAL_II_DEPRECATED
void do_reinit (const size_type m,
const size_type n,
const size_type local_rows,
const size_type local_columns,
const size_type n_nonzero_per_row,
const bool is_symmetric = false,
- const size_type n_offdiag_nonzero_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_offdiag_nonzero_per_row = 0);
/**
* Same as previous function.
* @deprecated This overload of <code>do_reinit</code> is deprecated:
* please use the overload with a sparsity pattern argument instead.
*/
+ DEAL_II_DEPRECATED
void do_reinit (const size_type m,
const size_type n,
const size_type local_rows,
const size_type local_columns,
const std::vector<size_type> &row_lengths,
const bool is_symmetric = false,
- const std::vector<size_type> &offdiag_row_lengths = std::vector<size_type>()) DEAL_II_DEPRECATED;
+ const std::vector<size_type> &offdiag_row_lengths = std::vector<size_type>());
/**
* Same as previous functions.
* @deprecated The use of objects that are explicitly of type VectorBase
* is deprecated: use PETScWrappers::MPI::Vector instead.
*/
+ DEAL_II_DEPRECATED
explicit Vector (const MPI_Comm &communicator,
const VectorBase &v,
- const size_type local_size) DEAL_II_DEPRECATED;
+ const size_type local_size);
/**
* Construct a new parallel ghosted PETSc vector from an IndexSet.
*/
void initialize(const PreconditionerBase &preconditioner);
- /**
- * Exception.
- *
- * @deprecated This function has been deprecated in favor of the more
- * general LACExceptions::ExcPETScError exception class.
- */
- DeclException1 (ExcPETScError,
- int,
- << "An error with error number " << arg1
- << " occurred while calling a PETSc function") DEAL_II_DEPRECATED;
-
protected:
/**
* If any of the <tt>b[i]</tt> is zero, the result is undefined. No
* attempt is made to catch such situations.
*/
+ DEAL_II_DEPRECATED
void ratio (const VectorBase &a,
- const VectorBase &b) DEAL_II_DEPRECATED;
+ const VectorBase &b);
/**
* Prints the PETSc vector object values using PETSc internal vector
* @author Guido Kanschat, 2000, 2001, 2002
*/
template <typename VectorType>
-class PointerMatrixBase : public Subscriptor
+class DEAL_II_DEPRECATED PointerMatrixBase : public Subscriptor
{
public:
/**
*/
virtual void Tvmult_add (VectorType &dst,
const VectorType &src) const = 0;
-} DEAL_II_DEPRECATED;
+};
/**
* @author Guido Kanschat 2000, 2001, 2002
*/
template <typename MatrixType, typename VectorType>
-class PointerMatrix : public PointerMatrixBase<VectorType>
+class DEAL_II_DEPRECATED PointerMatrix : public PointerMatrixBase<VectorType>
{
public:
/**
* The pointer to the actual matrix.
*/
SmartPointer<const MatrixType,PointerMatrix<MatrixType,VectorType> > m;
-} DEAL_II_DEPRECATED;
+};
/**
* @author Guido Kanschat 2006
*/
template <typename MatrixType, typename VectorType>
-class PointerMatrixAux : public PointerMatrixBase<VectorType>
+class DEAL_II_DEPRECATED PointerMatrixAux : public PointerMatrixBase<VectorType>
{
public:
/**
* The pointer to the actual matrix.
*/
SmartPointer<const MatrixType,PointerMatrixAux<MatrixType,VectorType> > m;
-} DEAL_II_DEPRECATED;
+};
* @author Guido Kanschat, 2006
*/
template <typename number>
-class PointerMatrixVector : public PointerMatrixBase<Vector<number> >
+class DEAL_II_DEPRECATED PointerMatrixVector : public PointerMatrixBase<Vector<number> >
{
public:
/**
* The pointer to the actual matrix.
*/
SmartPointer<const Vector<number>,PointerMatrixVector<number> > m;
-} DEAL_II_DEPRECATED;
+};
/**
* Set the initial vector for the solver.
*/
+ DEAL_II_DEPRECATED
void
set_initial_vector
- (const PETScWrappers::VectorBase &this_initial_vector) DEAL_II_DEPRECATED;
+ (const PETScWrappers::VectorBase &this_initial_vector);
/**
* Set the initial vector space for the solver.
* @author Wolfgang Bangerth, 1999, 2000
*/
template <typename number>
-class SwappableVector : public Vector<number>
+class DEAL_II_DEPRECATED SwappableVector : public Vector<number>
{
public:
/**
* to signal success itself if this is required.
*/
void reload_vector (const bool set_flag);
-} DEAL_II_DEPRECATED;
+};
/*@}*/
/*---------------------------- swappable_vector.h ---------------------------*/
*
* @deprecated Use the respective method with IndexSet arguments instead.
*/
+ DEAL_II_DEPRECATED
void reinit (const std::vector<Epetra_Map> &input_maps,
const ::dealii::BlockSparseMatrix<double> &deal_ii_sparse_matrix,
- const double drop_tolerance=1e-13) DEAL_II_DEPRECATED;
+ const double drop_tolerance=1e-13);
/**
* This function initializes the Trilinos matrix using the deal.II sparse
* @deprecated Use the methods of the individual matrices based on
* IndexSet arguments.
*/
- std::vector<Epetra_Map> domain_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ std::vector<Epetra_Map> domain_partitioner () const;
/**
* Return a vector of the underlying Trilinos Epetra_Map that sets the
* @deprecated Use the methods of the individual matrices based on
* IndexSet arguments.
*/
- std::vector<Epetra_Map> range_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ std::vector<Epetra_Map> range_partitioner () const;
/**
* Return the partitioning of the domain space for the individual blocks of
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
SparseMatrix (const Epetra_Map ¶llel_partitioning,
- const size_type n_max_entries_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_max_entries_per_row = 0);
/**
* Same as before, but now set a value of nonzeros for each matrix row.
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
SparseMatrix (const Epetra_Map ¶llel_partitioning,
- const std::vector<unsigned int> &n_entries_per_row) DEAL_II_DEPRECATED;
+ const std::vector<unsigned int> &n_entries_per_row);
/**
* This constructor is similar to the one above, but it now takes two
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
SparseMatrix (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
- const size_type n_max_entries_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_max_entries_per_row = 0);
/**
* This constructor is similar to the one above, but it now takes two
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
SparseMatrix (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
- const std::vector<unsigned int> &n_entries_per_row) DEAL_II_DEPRECATED;
+ const std::vector<unsigned int> &n_entries_per_row);
/**
* This function is initializes the Trilinos Epetra matrix according to
* @deprecated Use the respective method with IndexSet argument instead.
*/
template <typename SparsityPatternType>
+ DEAL_II_DEPRECATED
void reinit (const Epetra_Map ¶llel_partitioning,
const SparsityPatternType &sparsity_pattern,
- const bool exchange_data = false) DEAL_II_DEPRECATED;
+ const bool exchange_data = false);
/**
* This function is similar to the other initialization function above,
* @deprecated Use the respective method with IndexSet argument instead.
*/
template <typename SparsityPatternType>
+ DEAL_II_DEPRECATED
void reinit (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
const SparsityPatternType &sparsity_pattern,
- const bool exchange_data = false) DEAL_II_DEPRECATED;
+ const bool exchange_data = false);
/**
* This function initializes the Trilinos matrix using the deal.II sparse
* @deprecated Use the respective method with IndexSet argument instead.
*/
template <typename number>
+ DEAL_II_DEPRECATED
void reinit (const Epetra_Map ¶llel_partitioning,
const ::dealii::SparseMatrix<number> &dealii_sparse_matrix,
const double drop_tolerance=1e-13,
const bool copy_values=true,
- const ::dealii::SparsityPattern *use_this_sparsity=nullptr) DEAL_II_DEPRECATED;
+ const ::dealii::SparsityPattern *use_this_sparsity=nullptr);
/**
* This function is similar to the other initialization function with
* @deprecated Use the respective method with IndexSet argument instead.
*/
template <typename number>
+ DEAL_II_DEPRECATED
void reinit (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
const ::dealii::SparseMatrix<number> &dealii_sparse_matrix,
const double drop_tolerance=1e-13,
const bool copy_values=true,
- const ::dealii::SparsityPattern *use_this_sparsity=nullptr) DEAL_II_DEPRECATED;
+ const ::dealii::SparsityPattern *use_this_sparsity=nullptr);
//@}
/**
* @name Constructors and initialization using an IndexSet description
*
* @deprecated Use locally_owned_domain_indices() instead.
*/
- const Epetra_Map &domain_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Map &domain_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
*
* @deprecated Use locally_owned_range_indices() instead.
*/
- const Epetra_Map &range_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Map &range_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
*
* @deprecated Use locally_owned_range_indices() instead.
*/
- const Epetra_Map &row_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Map &row_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
* @deprecated Usually not necessary. If desired, access it via the
* Epetra_CrsMatrix.
*/
- const Epetra_Map &col_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Map &col_partitioner () const;
//@}
/**
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
SparsityPattern (const Epetra_Map ¶llel_partitioning,
- const size_type n_entries_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_entries_per_row = 0);
/**
* Same as before, but now use the exact number of nonzeros in each m row.
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
SparsityPattern (const Epetra_Map ¶llel_partitioning,
- const std::vector<size_type> &n_entries_per_row) DEAL_II_DEPRECATED;
+ const std::vector<size_type> &n_entries_per_row);
/**
* This constructor is similar to the one above, but it now takes two
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
SparsityPattern (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
- const size_type n_entries_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_entries_per_row = 0);
/**
* This constructor is similar to the one above, but it now takes two
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
SparsityPattern (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
- const std::vector<size_type> &n_entries_per_row) DEAL_II_DEPRECATED;
+ const std::vector<size_type> &n_entries_per_row);
/**
* Reinitialization function for generating a square sparsity pattern
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
void
reinit (const Epetra_Map ¶llel_partitioning,
- const size_type n_entries_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_entries_per_row = 0);
/**
* Same as before, but now use the exact number of nonzeros in each m row.
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
void
reinit (const Epetra_Map ¶llel_partitioning,
- const std::vector<size_type> &n_entries_per_row) DEAL_II_DEPRECATED;
+ const std::vector<size_type> &n_entries_per_row);
/**
* This reinit function is similar to the one above, but it now takes two
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
void
reinit (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
- const size_type n_entries_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_entries_per_row = 0);
/**
* This reinit function is similar to the one above, but it now takes two
*
* @deprecated Use the respective method with IndexSet argument instead.
*/
+ DEAL_II_DEPRECATED
void
reinit (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
- const std::vector<size_type> &n_entries_per_row) DEAL_II_DEPRECATED;
+ const std::vector<size_type> &n_entries_per_row);
/**
* Reinit function. Takes one of the deal.II sparsity patterns and a
* @deprecated Use the respective method with IndexSet argument instead.
*/
template <typename SparsityPatternType>
+ DEAL_II_DEPRECATED
void
reinit (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
const SparsityPatternType &nontrilinos_sparsity_pattern,
- const bool exchange_data = false) DEAL_II_DEPRECATED;
+ const bool exchange_data = false);
/**
* Reinit function. Takes one of the deal.II sparsity patterns and a
* @deprecated Use the respective method with IndexSet argument instead.
*/
template <typename SparsityPatternType>
+ DEAL_II_DEPRECATED
void
reinit (const Epetra_Map ¶llel_partitioning,
const SparsityPatternType &nontrilinos_sparsity_pattern,
- const bool exchange_data = false) DEAL_II_DEPRECATED;
+ const bool exchange_data = false);
//@}
/**
* @name Constructors and initialization using an IndexSet description
*
* @deprecated Use locally_owned_domain_indices() instead.
*/
- const Epetra_Map &domain_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Map &domain_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
*
* @deprecated Use locally_owned_range_indices() instead.
*/
- const Epetra_Map &range_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Map &range_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
*
* @deprecated Use locally_owned_range_indices() instead.
*/
- const Epetra_Map &row_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Map &row_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
* @deprecated Usually not necessary. If desired, access via the
* Epetra_FECrsGraph.
*/
- const Epetra_Map &col_partitioner () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Map &col_partitioner () const;
/**
* Return a const reference to the communicator used for this object.
*
* @deprecated Use get_mpi_communicator instead.
*/
- const Epetra_Comm &trilinos_communicator () const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ const Epetra_Comm &trilinos_communicator () const;
/**
* Return the MPI communicator object in use with this matrix.
*
* @dealiiOperationIsMultithreaded
*/
+ DEAL_II_DEPRECATED
void ratio (const Vector<Number> &a,
- const Vector<Number> &b) DEAL_II_DEPRECATED;
+ const Vector<Number> &b);
/**
* This function does nothing but exists for compatibility with the @p
*
* This function is deprecated.
*/
- void print (const char *format = nullptr) const DEAL_II_DEPRECATED;
+ DEAL_II_DEPRECATED
+ void print (const char *format = nullptr) const;
/**
* Print to a stream. @p precision denotes the desired precision with which
*
* This function is deprecated.
*/
+ DEAL_II_DEPRECATED
void print (LogStream &out,
const unsigned int width = 6,
- const bool across = true) const DEAL_II_DEPRECATED;
+ const bool across = true) const;
/**
* Write the vector en bloc to a file. This is done in a binary mode, so the
* @deprecated Use ArrayView instead.
*/
template <typename Number>
-class VectorView : public Vector<Number>
+class DEAL_II_DEPRECATED VectorView : public Vector<Number>
{
public:
* called, and will throw an exception if you try to do so.
*/
virtual void swap (Vector<Number> &v);
-} DEAL_II_DEPRECATED;
+};
* one provided by DoFHandler::locally_owned_dofs().
*/
template <typename DoFHandlerType, typename QuadratureType>
+ DEAL_II_DEPRECATED
void reinit (const Mapping<dim> &mapping,
const DoFHandlerType &dof_handler,
const ConstraintMatrix &constraint,
const IndexSet &locally_owned_dofs,
const QuadratureType &quad,
- const AdditionalData additional_data = AdditionalData()) DEAL_II_DEPRECATED;
+ const AdditionalData additional_data = AdditionalData());
/**
* Extracts the information needed to perform loops over cells. The
* one provided by DoFHandler::locally_owned_dofs().
*/
template <typename DoFHandlerType, typename QuadratureType>
+ DEAL_II_DEPRECATED
void reinit (const Mapping<dim> &mapping,
const std::vector<const DoFHandlerType *> &dof_handler,
const std::vector<const ConstraintMatrix *> &constraint,
const std::vector<IndexSet> &locally_owned_set,
const std::vector<QuadratureType> &quad,
- const AdditionalData additional_data = AdditionalData()) DEAL_II_DEPRECATED;
+ const AdditionalData additional_data = AdditionalData());
/**
* Initializes the data structures. Same as before, but now the index set
*
* Constructor. Sets memory and smoothing parameters.
*/
+ DEAL_II_DEPRECATED
MGSmootherBlock (VectorMemory<BlockVector<number> > &mem,
const unsigned int steps = 1,
const bool variable = false,
const bool symmetric = false,
const bool transpose = false,
- const bool reverse = false) DEAL_II_DEPRECATED;
+ const bool reverse = false);
/**
* Constructor.
* @author Guido Kanschat, 1999, Ralf Hartmann, 2002.
*/
template <typename SolverType, class VectorType = Vector<double> >
-class MGCoarseGridLACIteration : public MGCoarseGridBase<VectorType>
+class DEAL_II_DEPRECATED MGCoarseGridLACIteration : public MGCoarseGridBase<VectorType>
{
public:
/**
*/
LinearOperator<VectorType> precondition;
-} DEAL_II_DEPRECATED;
+};
* @deprecated Use initialize() followed by make_zero_boundary_constraints() instead
*/
template <int dim, int spacedim>
+ DEAL_II_DEPRECATED
void initialize(const DoFHandler<dim,spacedim> &dof,
const typename FunctionMap<dim>::type &function_map,
- const ComponentMask &component_mask = ComponentMask()) DEAL_II_DEPRECATED;
+ const ComponentMask &component_mask = ComponentMask());
/**
* Fill the internal data structures with information
*
* @deprecated @p constraints is unused.
*/
+ DEAL_II_DEPRECATED
MGTransferPrebuilt (const ConstraintMatrix &constraints,
- const MGConstrainedDoFs &mg_constrained_dofs) DEAL_II_DEPRECATED;
+ const MGConstrainedDoFs &mg_constrained_dofs);
/**
* Destructor.
*
* @deprecated @p constraints is unused.
*/
+ DEAL_II_DEPRECATED
void initialize_constraints (const ConstraintMatrix &constraints,
- const MGConstrainedDoFs &mg_constrained_dofs) DEAL_II_DEPRECATED;
+ const MGConstrainedDoFs &mg_constrained_dofs);
/**
* Reset the object to the state it had right after the default constructor.
*
* @deprecated @p constraints is unused.
*/
+ DEAL_II_DEPRECATED
MGTransferBlockBase (const ConstraintMatrix &constraints,
- const MGConstrainedDoFs &mg_constrained_dofs) DEAL_II_DEPRECATED;
+ const MGConstrainedDoFs &mg_constrained_dofs);
/**
* Memory used by this object.
*
* @deprecated @p constraints is unused.
*/
+ DEAL_II_DEPRECATED
MGTransferBlockSelect (const ConstraintMatrix &constraints,
- const MGConstrainedDoFs &mg_constrained_dofs) DEAL_II_DEPRECATED;
+ const MGConstrainedDoFs &mg_constrained_dofs);
/**
* Destructor.
* The DoFHandler is actually not needed.
*/
template <int dim>
+ DEAL_II_DEPRECATED
Multigrid(const DoFHandler<dim> &mg_dof_handler,
const MGMatrixBase<VectorType> &matrix,
const MGCoarseGridBase<VectorType> &coarse,
const MGSmootherBase<VectorType> &post_smooth,
const unsigned int minlevel = 0,
const unsigned int maxlevel = numbers::invalid_unsigned_int,
- Cycle cycle = v_cycle) DEAL_II_DEPRECATED;
+ Cycle cycle = v_cycle);
/**
* Constructor. <tt>transfer</tt> is an object performing prolongation and
* @author Luca Heltai, Andrea Mola, 2011--2014.
*/
template <int dim, int spacedim>
- class NormalProjectionBoundary : public Boundary<dim,spacedim>
+ class DEAL_II_DEPRECATED NormalProjectionBoundary : public Boundary<dim,spacedim>
{
public:
* Relative tolerance used by this class to compute distances.
*/
const double tolerance;
- } DEAL_II_DEPRECATED;
+ };
/**
* A Boundary object based on OpenCASCADE TopoDS_Shape where new points are
* @author Luca Heltai, Andrea Mola, 2011--2014.
*/
template <int dim, int spacedim>
- class DirectionalProjectionBoundary : public Boundary<dim,spacedim>
+ class DEAL_II_DEPRECATED DirectionalProjectionBoundary : public Boundary<dim,spacedim>
{
public:
/**
* Relative tolerance used by this class to compute distances.
*/
const double tolerance;
- } DEAL_II_DEPRECATED;
+ };
/**
* @author Luca Heltai, Andrea Mola, 2011--2014.
*/
template <int dim, int spacedim>
- class NormalToMeshProjectionBoundary : public Boundary<dim,spacedim>
+ class DEAL_II_DEPRECATED NormalToMeshProjectionBoundary : public Boundary<dim,spacedim>
{
public:
/**
* Relative tolerance used by this class to compute distances.
*/
const double tolerance;
- } DEAL_II_DEPRECATED;
+ };
/**
* A Boundary object based on OpenCASCADE TopoDS_Shape objects which have