From c710db7669f5c7be263adb1ec868a7d7c3443cdd Mon Sep 17 00:00:00 2001 From: maier Date: Mon, 26 Nov 2012 14:37:12 +0000 Subject: [PATCH] Add DEAL_II_DEPRECATED attributes to deprecated fucntions and classes git-svn-id: https://svn.dealii.org/branches/branch_deprecated@27686 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/include/deal.II/base/logstream.h | 4 ++-- .../include/deal.II/base/mg_level_object.h | 4 ++-- deal.II/include/deal.II/base/table.h | 2 +- .../include/deal.II/base/thread_management.h | 6 +++--- deal.II/include/deal.II/base/types.h | 12 +++++------ deal.II/include/deal.II/base/utilities.h | 8 ++++---- deal.II/include/deal.II/dofs/dof_handler.h | 4 ++-- .../include/deal.II/dofs/dof_renumbering.h | 14 ++++++------- deal.II/include/deal.II/dofs/dof_tools.h | 4 ++-- deal.II/include/deal.II/fe/fe_base.h | 2 +- deal.II/include/deal.II/fe/fe_values.h | 20 +++++++++---------- deal.II/include/deal.II/fe/mapping.h | 8 ++++---- deal.II/include/deal.II/grid/grid_tools.h | 2 +- deal.II/include/deal.II/grid/tria.h | 19 +++++++++--------- deal.II/include/deal.II/lac/block_list.h | 14 ++++++------- .../include/deal.II/lac/block_matrix_array.h | 14 ++++++------- .../deal.II/lac/block_sparsity_pattern.h | 2 +- deal.II/include/deal.II/lac/block_vector.h | 2 +- .../include/deal.II/lac/block_vector_base.h | 2 +- .../deal.II/lac/parallel_block_vector.h | 2 +- deal.II/include/deal.II/lac/parallel_vector.h | 2 +- .../include/deal.II/lac/precondition_block.h | 2 +- .../include/deal.II/lac/relaxation_block.h | 2 +- .../deal.II/lac/sparse_decomposition.h | 8 ++++---- deal.II/include/deal.II/lac/sparse_ilu.h | 6 +++--- deal.II/include/deal.II/lac/sparse_matrix.h | 6 +++--- deal.II/include/deal.II/lac/sparse_mic.h | 4 ++-- .../include/deal.II/lac/sparsity_pattern.h | 8 ++++---- .../deal.II/lac/trilinos_block_vector.h | 2 +- .../lac/trilinos_parallel_block_vector.h | 2 +- .../deal.II/lac/trilinos_vector_base.h | 2 +- deal.II/include/deal.II/lac/vector.h | 2 +- deal.II/include/deal.II/multigrid/mg_matrix.h | 2 +- .../include/deal.II/multigrid/mg_smoother.h | 2 +- deal.II/include/deal.II/multigrid/mg_tools.h | 2 +- deal.II/include/deal.II/multigrid/multigrid.h | 8 ++++---- .../deal.II/numerics/data_postprocessor.h | 4 ++-- .../deal.II/numerics/point_value_history.h | 2 +- .../include/deal.II/numerics/vector_tools.h | 4 ++-- 39 files changed, 108 insertions(+), 107 deletions(-) diff --git a/deal.II/include/deal.II/base/logstream.h b/deal.II/include/deal.II/base/logstream.h index cb50979e38..83a98105fd 100644 --- a/deal.II/include/deal.II/base/logstream.h +++ b/deal.II/include/deal.II/base/logstream.h @@ -216,14 +216,14 @@ public: * colon and there is a double * colon after the last prefix. */ - void push (const std::string &text); + void push (const std::string &text) DEAL_II_DEPRECATED; /** * @deprecated Use Prefix instead * * Remove the last prefix. */ - void pop (); + void pop () DEAL_II_DEPRECATED; /** * Maximum number of levels to be diff --git a/deal.II/include/deal.II/base/mg_level_object.h b/deal.II/include/deal.II/base/mg_level_object.h index 89dae1ab30..eca7a5f534 100644 --- a/deal.II/include/deal.II/base/mg_level_object.h +++ b/deal.II/include/deal.II/base/mg_level_object.h @@ -100,12 +100,12 @@ public: /** * @deprecated Replaced by min_level() */ - unsigned int get_minlevel () const; + unsigned int get_minlevel () const DEAL_II_DEPRECATED; /** * @deprecated Replaced by max_level() */ - unsigned int get_maxlevel () const; + unsigned int get_maxlevel () const DEAL_II_DEPRECATED; /** * Memory used by this object. diff --git a/deal.II/include/deal.II/base/table.h b/deal.II/include/deal.II/base/table.h index fc28f61f82..607eb1a7eb 100644 --- a/deal.II/include/deal.II/base/table.h +++ b/deal.II/include/deal.II/base/table.h @@ -700,7 +700,7 @@ protected: * cast from const), otherwise, * keep away! */ - typename std::vector::const_pointer data () const; + typename std::vector::const_pointer data () const DEAL_II_DEPRECATED; protected: /** diff --git a/deal.II/include/deal.II/base/thread_management.h b/deal.II/include/deal.II/base/thread_management.h index a99fba0146..28092d867f 100644 --- a/deal.II/include/deal.II/base/thread_management.h +++ b/deal.II/include/deal.II/base/thread_management.h @@ -571,7 +571,7 @@ namespace Threads * * @deprecated */ - typedef Mutex ThreadMutex; + typedef Mutex ThreadMutex DEAL_II_DEPRECATED; /** * Provide a backward compatible name (we @@ -581,7 +581,7 @@ namespace Threads * * @deprecated */ - typedef ConditionVariable ThreadCondition; + typedef ConditionVariable ThreadCondition DEAL_II_DEPRECATED; /** * If using POSIX functions, then @@ -589,7 +589,7 @@ namespace Threads * to the names we use throughout * the library. */ - typedef PosixThreadBarrier Barrier; + typedef PosixThreadBarrier Barrier; #else /** diff --git a/deal.II/include/deal.II/base/types.h b/deal.II/include/deal.II/base/types.h index e635865640..de4956585e 100644 --- a/deal.II/include/deal.II/base/types.h +++ b/deal.II/include/deal.II/base/types.h @@ -40,17 +40,17 @@ namespace types /** * @deprecated Old name for the typedef above. */ - typedef subdomain_id subdomain_id_t; + typedef subdomain_id subdomain_id_t DEAL_II_DEPRECATED; /** * @deprecated Use numbers::invalid_subdomain_id */ - const unsigned int invalid_subdomain_id = static_cast(-1); + const unsigned int invalid_subdomain_id DEAL_II_DEPRECATED = static_cast(-1); /** * @deprecated Use numbers::artificial_subdomain_id */ - const unsigned int artificial_subdomain_id = static_cast(-2); + const unsigned int artificial_subdomain_id DEAL_II_DEPRECATED = static_cast(-2); /** * The type used to denote global dof @@ -61,7 +61,7 @@ namespace types /** * @deprecated Use numbers::invalid_dof_index */ - const global_dof_index invalid_dof_index = static_cast(-1); + const global_dof_index invalid_dof_index DEAL_II_DEPRECATED = static_cast(-1); /** * The type used to denote boundary indicators associated with every @@ -79,7 +79,7 @@ namespace types /** * @deprecated Old name for the typedef above. */ - typedef boundary_id boundary_id_t; + typedef boundary_id boundary_id_t DEAL_II_DEPRECATED; /** * The type used to denote material indicators associated with every @@ -93,7 +93,7 @@ namespace types /** * @deprecated Old name for the typedef above. */ - typedef material_id material_id_t; + typedef material_id material_id_t DEAL_II_DEPRECATED; } diff --git a/deal.II/include/deal.II/base/utilities.h b/deal.II/include/deal.II/base/utilities.h index 355d46a74d..828f23ce04 100644 --- a/deal.II/include/deal.II/base/utilities.h +++ b/deal.II/include/deal.II/base/utilities.h @@ -388,7 +388,7 @@ namespace Utilities * * @deprecated */ - bool program_uses_mpi (); + bool program_uses_mpi () DEAL_II_DEPRECATED; /** * @name Functions that work @@ -406,7 +406,7 @@ namespace Utilities * * @deprecated */ - unsigned int get_n_mpi_processes (const MPI_Comm &mpi_communicator); + unsigned int get_n_mpi_processes (const MPI_Comm &mpi_communicator) DEAL_II_DEPRECATED; /** * This function is an alias for @@ -414,7 +414,7 @@ namespace Utilities * * @deprecated */ - unsigned int get_this_mpi_process (const MPI_Comm &mpi_communicator); + unsigned int get_this_mpi_process (const MPI_Comm &mpi_communicator) DEAL_II_DEPRECATED; /** @@ -450,7 +450,7 @@ namespace Utilities void calculate_collective_mpi_min_max_avg (const MPI_Comm &mpi_communicator, const double my_value, - MinMaxAvg &result); + MinMaxAvg &result) DEAL_II_DEPRECATED; /** * An alias for Utilities::MPI::MPI_InitFinalize. diff --git a/deal.II/include/deal.II/dofs/dof_handler.h b/deal.II/include/deal.II/dofs/dof_handler.h index 707eaedf8e..86973e9506 100644 --- a/deal.II/include/deal.II/dofs/dof_handler.h +++ b/deal.II/include/deal.II/dofs/dof_handler.h @@ -444,7 +444,7 @@ public: * is also discussed in the documentation * of the module on @ref Sparsity. */ - unsigned int max_couplings_between_dofs () const; + unsigned int max_couplings_between_dofs () const DEAL_II_DEPRECATED; /** * @deprecated Use @@ -461,7 +461,7 @@ public: * max_couplings_between_dofs() in one * dimension less. */ - unsigned int max_couplings_between_boundary_dofs () const; + unsigned int max_couplings_between_boundary_dofs () const DEAL_II_DEPRECATED; /*--------------------------------------*/ diff --git a/deal.II/include/deal.II/dofs/dof_renumbering.h b/deal.II/include/deal.II/dofs/dof_renumbering.h index d5f789cf89..3326700325 100644 --- a/deal.II/include/deal.II/dofs/dof_renumbering.h +++ b/deal.II/include/deal.II/dofs/dof_renumbering.h @@ -962,7 +962,7 @@ namespace DoFRenumbering template void cell_wise_dg (DH &dof_handler, - const std::vector &cell_order); + const std::vector &cell_order) DEAL_II_DEPRECATED; /** * Computes the renumbering @@ -1019,7 +1019,7 @@ namespace DoFRenumbering void cell_wise_dg (MGDoFHandler &dof_handler, const unsigned int level, - const std::vector::cell_iterator> &cell_order); + const std::vector::cell_iterator> &cell_order) DEAL_II_DEPRECATED; /** * Computes the renumbering @@ -1120,7 +1120,7 @@ namespace DoFRenumbering template void downstream_dg (DH &dof_handler, - const Point &direction); + const Point &direction) DEAL_II_DEPRECATED; /** * Cell-wise downstream numbering @@ -1144,7 +1144,7 @@ namespace DoFRenumbering void downstream_dg (MGDoFHandler &dof_handler, const unsigned int level, - const Point &direction); + const Point &direction) DEAL_II_DEPRECATED; /** * @deprecated The new function @@ -1166,7 +1166,7 @@ namespace DoFRenumbering void compute_downstream_dg (std::vector &new_dof_indices, const DH &dof_handler, - const Point &direction); + const Point &direction) DEAL_II_DEPRECATED; /** * Computes the renumbering @@ -1194,7 +1194,7 @@ namespace DoFRenumbering compute_downstream_dg (std::vector &new_dof_indices, std::vector &reverse, const DH &dof_handler, - const Point &direction); + const Point &direction) DEAL_II_DEPRECATED; /** * Computes the renumbering @@ -1224,7 +1224,7 @@ namespace DoFRenumbering std::vector &reverse, const MGDoFHandler &dof_handler, const unsigned int level, - const Point &direction); + const Point &direction) DEAL_II_DEPRECATED; /** * Cell-wise clockwise numbering. diff --git a/deal.II/include/deal.II/dofs/dof_tools.h b/deal.II/include/deal.II/dofs/dof_tools.h index 85c056453f..4489a4eff1 100644 --- a/deal.II/include/deal.II/dofs/dof_tools.h +++ b/deal.II/include/deal.II/dofs/dof_tools.h @@ -677,7 +677,7 @@ namespace DoFTools void make_sparsity_pattern (const DH &dof, const std::vector > &mask, - SparsityPattern &sparsity_pattern); + SparsityPattern &sparsity_pattern) DEAL_II_DEPRECATED; /** * Construct a sparsity pattern that @@ -2203,7 +2203,7 @@ namespace DoFTools void count_dofs_per_component (const DoFHandler &dof_handler, std::vector &dofs_per_component, - std::vector target_component); + std::vector target_component) DEAL_II_DEPRECATED; /** * This function can be used when diff --git a/deal.II/include/deal.II/fe/fe_base.h b/deal.II/include/deal.II/fe/fe_base.h index 0fb62efe65..f46cc12303 100644 --- a/deal.II/include/deal.II/fe/fe_base.h +++ b/deal.II/include/deal.II/fe/fe_base.h @@ -629,7 +629,7 @@ public: * @endcode * */ - unsigned int face_to_equivalent_cell_index (const unsigned int index) const; + unsigned int face_to_equivalent_cell_index (const unsigned int index) const DEAL_II_DEPRECATED; /** * Comparison operator. diff --git a/deal.II/include/deal.II/fe/fe_values.h b/deal.II/include/deal.II/fe/fe_values.h index 81a8e17349..801aa33fd5 100644 --- a/deal.II/include/deal.II/fe/fe_values.h +++ b/deal.II/include/deal.II/fe/fe_values.h @@ -1855,7 +1855,7 @@ public: */ const Tensor<2,spacedim> & shape_2nd_derivative (const unsigned int function_no, - const unsigned int point_no) const; + const unsigned int point_no) const DEAL_II_DEPRECATED; /** @@ -1899,7 +1899,7 @@ public: Tensor<2,spacedim> shape_2nd_derivative_component (const unsigned int function_no, const unsigned int point_no, - const unsigned int component) const; + const unsigned int component) const DEAL_II_DEPRECATED; //@} @@ -2287,7 +2287,7 @@ public: */ template void get_function_grads (const InputVector &fe_function, - std::vector > &gradients) const; + std::vector > &gradients) const DEAL_II_DEPRECATED; /** * @deprecated Use @@ -2295,7 +2295,7 @@ public: */ template void get_function_grads (const InputVector &fe_function, - std::vector > > &gradients) const; + std::vector > > &gradients) const DEAL_II_DEPRECATED; /** * @deprecated Use @@ -2304,7 +2304,7 @@ public: template void get_function_grads (const InputVector &fe_function, const VectorSlice > &indices, - std::vector > &gradients) const; + std::vector > &gradients) const DEAL_II_DEPRECATED; /** * @deprecated Use @@ -2314,7 +2314,7 @@ public: void get_function_grads (const InputVector &fe_function, const VectorSlice > &indices, std::vector > > &gradients, - bool quadrature_points_fastest = false) const; + bool quadrature_points_fastest = false) const DEAL_II_DEPRECATED; //@} /// @name Access to second derivatives (Hessian matrices and Laplacians) of global finite element fields @@ -2466,7 +2466,7 @@ public: template void get_function_2nd_derivatives (const InputVector &, - std::vector > &) const; + std::vector > &) const DEAL_II_DEPRECATED; /** * @deprecated Wrapper for get_function_hessians() @@ -2475,7 +2475,7 @@ public: void get_function_2nd_derivatives (const InputVector &, std::vector > > &, - bool = false) const; + bool = false) const DEAL_II_DEPRECATED; /** * Compute the (scalar) Laplacian (i.e. the trace of the tensor of second @@ -2777,7 +2777,7 @@ public: * point. The length of the vector * is normalized to one. */ - const Point &cell_normal_vector (const unsigned int i) const; + const Point &cell_normal_vector (const unsigned int i) const DEAL_II_DEPRECATED; /** * @deprecated Use @@ -2787,7 +2787,7 @@ public: * the cell in each of the * quadrature points. */ - const std::vector > &get_cell_normal_vectors () const; + const std::vector > &get_cell_normal_vectors () const DEAL_II_DEPRECATED; //@} diff --git a/deal.II/include/deal.II/fe/mapping.h b/deal.II/include/deal.II/fe/mapping.h index 73a327eded..3a5dc60777 100644 --- a/deal.II/include/deal.II/fe/mapping.h +++ b/deal.II/include/deal.II/fe/mapping.h @@ -609,7 +609,7 @@ public: transform_covariant (const VectorSlice > > input, const unsigned int offset, VectorSlice > > output, - const InternalDataBase &internal) const; + const InternalDataBase &internal) const DEAL_II_DEPRECATED; /** * @deprecated Use transform() instead. @@ -618,7 +618,7 @@ public: transform_covariant (const VectorSlice > > input, const unsigned int offset, VectorSlice > > output, - const InternalDataBase &internal) const; + const InternalDataBase &internal) const DEAL_II_DEPRECATED; /** * @deprecated Use transform() instead. @@ -627,7 +627,7 @@ public: transform_contravariant (const VectorSlice > > input, const unsigned int offset, VectorSlice > > output, - const typename Mapping::InternalDataBase &internal) const; + const typename Mapping::InternalDataBase &internal) const DEAL_II_DEPRECATED; /** * @deprecated Use transform() instead. @@ -637,7 +637,7 @@ public: transform_contravariant (const VectorSlice > > input, const unsigned int offset, const VectorSlice > > output, - const typename Mapping::InternalDataBase &internal) const; + const typename Mapping::InternalDataBase &internal) const DEAL_II_DEPRECATED; /** * The transformed (generalized) diff --git a/deal.II/include/deal.II/grid/grid_tools.h b/deal.II/include/deal.II/grid/grid_tools.h index 774e5a32cc..bea556bdaf 100644 --- a/deal.II/include/deal.II/grid/grid_tools.h +++ b/deal.II/include/deal.II/grid/grid_tools.h @@ -298,7 +298,7 @@ namespace GridTools template class Container, int spacedim> std::vector::active_cell_iterator> find_cells_adjacent_to_vertex (const Container &container, - const unsigned int vertex); + const unsigned int vertex) DEAL_II_DEPRECATED; /** diff --git a/deal.II/include/deal.II/grid/tria.h b/deal.II/include/deal.II/grid/tria.h index e47add785f..86eace851c 100644 --- a/deal.II/include/deal.II/grid/tria.h +++ b/deal.II/include/deal.II/grid/tria.h @@ -1475,7 +1475,7 @@ public: * * @deprecated */ - virtual ~RefinementListener (); + virtual ~RefinementListener () DEAL_II_DEPRECATED; /** * Before refinement is actually @@ -1493,7 +1493,7 @@ public: */ virtual void - pre_refinement_notification (const Triangulation &tria); + pre_refinement_notification (const Triangulation &tria) DEAL_II_DEPRECATED; /** * After refinement is actually @@ -1511,7 +1511,7 @@ public: */ virtual void - post_refinement_notification (const Triangulation &tria); + post_refinement_notification (const Triangulation &tria) DEAL_II_DEPRECATED; /** * At the end of a call to @@ -1537,7 +1537,7 @@ public: virtual void copy_notification (const Triangulation &old_tria, - const Triangulation &new_tria); + const Triangulation &new_tria) DEAL_II_DEPRECATED; /** * At the end of a call to @@ -1559,8 +1559,9 @@ public: */ virtual void - create_notification (const Triangulation &tria); - }; + create_notification (const Triangulation &tria) DEAL_II_DEPRECATED; + + } DEAL_II_DEPRECATED; /** * A structure that is used as an @@ -2196,7 +2197,7 @@ public: * * @deprecated */ - void add_refinement_listener (RefinementListener &listener) const; + void add_refinement_listener (RefinementListener &listener) const DEAL_II_DEPRECATED; /** * Remove a @@ -2214,7 +2215,7 @@ public: * * @deprecated */ - void remove_refinement_listener (RefinementListener &listener) const; + void remove_refinement_listener (RefinementListener &listener) const DEAL_II_DEPRECATED; /** * A structure that has boost::signal objects for a number of actions that a @@ -2460,7 +2461,7 @@ public: * Clear all user pointers. * See also @ref GlossUserData . */ - void clear_user_pointers (); + void clear_user_pointers () DEAL_II_DEPRECATED; /** * Save all user indices. The diff --git a/deal.II/include/deal.II/lac/block_list.h b/deal.II/include/deal.II/lac/block_list.h index d40c9c9814..04c312d806 100644 --- a/deal.II/include/deal.II/lac/block_list.h +++ b/deal.II/include/deal.II/lac/block_list.h @@ -135,7 +135,7 @@ public: template void initialize_mg(unsigned int n_blocks, const ITERATOR begin, - const typename identity::type end); + const typename identity::type end) DEAL_II_DEPRECATED; /** * @deprecated This function will @@ -173,7 +173,7 @@ public: const ITERATOR begin, const typename identity::type end, const std::vector &selected_dofs, - unsigned int offset = 0); + unsigned int offset = 0) DEAL_II_DEPRECATED; /** * @deprecated This function will * move to DoFTools. @@ -210,7 +210,7 @@ public: const ITERATOR begin, const typename identity::type end, const std::vector &selected_dofs, - unsigned int offset = 0); + unsigned int offset = 0) DEAL_II_DEPRECATED; /** * @deprecated This function will @@ -228,7 +228,7 @@ public: const ITERATOR begin, const typename identity::type end, const std::vector &selected_dofs = std::vector(), - unsigned int offset = 0); + unsigned int offset = 0) DEAL_II_DEPRECATED; /** * @deprecated This function will @@ -241,7 +241,7 @@ public: unsigned int count_vertex_patches( const ITERATOR begin, const typename identity::type end, - bool same_level_only) const; + bool same_level_only) const DEAL_II_DEPRECATED; /** * @deprecated This function will @@ -250,7 +250,7 @@ public: */ template bool cell_generates_vertex_patch(const ITERATOR cell, - bool same_level_only) const; + bool same_level_only) const DEAL_II_DEPRECATED; /** * The number of blocks. @@ -284,7 +284,7 @@ private: * The container for t he index sets. */ std::vector index_sets; -}; +} DEAL_II_DEPRECATED; inline diff --git a/deal.II/include/deal.II/lac/block_matrix_array.h b/deal.II/include/deal.II/lac/block_matrix_array.h index 028ead966e..c9eeb5b8d9 100644 --- a/deal.II/include/deal.II/lac/block_matrix_array.h +++ b/deal.II/include/deal.II/lac/block_matrix_array.h @@ -149,7 +149,7 @@ public: * is ignored. */ void initialize (const unsigned int n_block_rows, - const unsigned int n_block_cols); + const unsigned int n_block_cols) DEAL_II_DEPRECATED; /** * Constructor fixing the @@ -160,7 +160,7 @@ public: */ BlockMatrixArray (const unsigned int n_block_rows, const unsigned int n_block_cols, - VectorMemory > &mem); + VectorMemory > &mem) DEAL_II_DEPRECATED; /** * Initialize object @@ -174,7 +174,7 @@ public: */ void initialize (const unsigned int n_block_rows, const unsigned int n_block_cols, - VectorMemory > &mem); + VectorMemory > &mem) DEAL_II_DEPRECATED; /** * Adjust the matrix to a new @@ -224,7 +224,7 @@ public: const unsigned int row, const unsigned int col, const double prefix = 1., - const bool transpose = false); + const bool transpose = false) DEAL_II_DEPRECATED; /** @@ -500,7 +500,7 @@ public: */ BlockTrianglePrecondition (unsigned int n_block_rows, VectorMemory > &mem, - bool backward = false); + bool backward = false) DEAL_II_DEPRECATED; /** * Initialize object @@ -514,7 +514,7 @@ public: */ void initialize (const unsigned int n_block_rows, VectorMemory > &mem, - bool backward = false); + bool backward = false) DEAL_II_DEPRECATED; /** * Resize preconditioner to a new @@ -554,7 +554,7 @@ public: const unsigned int row, const unsigned int col, const double prefix = 1., - const bool transpose = false); + const bool transpose = false) DEAL_II_DEPRECATED; /** * Preconditioning. diff --git a/deal.II/include/deal.II/lac/block_sparsity_pattern.h b/deal.II/include/deal.II/lac/block_sparsity_pattern.h index ef700e9218..9b412967b0 100644 --- a/deal.II/include/deal.II/lac/block_sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/block_sparsity_pattern.h @@ -745,7 +745,7 @@ public: * * @deprecated */ -typedef BlockCompressedSparsityPattern CompressedBlockSparsityPattern; +typedef BlockCompressedSparsityPattern CompressedBlockSparsityPattern DEAL_II_DEPRECATED; diff --git a/deal.II/include/deal.II/lac/block_vector.h b/deal.II/include/deal.II/lac/block_vector.h index c090a14a51..2ce6364d1b 100644 --- a/deal.II/include/deal.II/lac/block_vector.h +++ b/deal.II/include/deal.II/lac/block_vector.h @@ -368,7 +368,7 @@ public: * @deprecated Use operator*= * instead. */ - void scale (const value_type factor); + void scale (const value_type factor) DEAL_II_DEPRECATED; /** * Multiply each element of this diff --git a/deal.II/include/deal.II/lac/block_vector_base.h b/deal.II/include/deal.II/lac/block_vector_base.h index a36f8daf8c..28d6efc9bd 100644 --- a/deal.II/include/deal.II/lac/block_vector_base.h +++ b/deal.II/include/deal.II/lac/block_vector_base.h @@ -816,7 +816,7 @@ public: * versions */ const BlockIndices & - get_block_indices () const; + get_block_indices () const DEAL_II_DEPRECATED; /** * Number of blocks. diff --git a/deal.II/include/deal.II/lac/parallel_block_vector.h b/deal.II/include/deal.II/lac/parallel_block_vector.h index 76c81f708a..221570efd0 100644 --- a/deal.II/include/deal.II/lac/parallel_block_vector.h +++ b/deal.II/include/deal.II/lac/parallel_block_vector.h @@ -284,7 +284,7 @@ namespace parallel * @deprecated Use operator*= * instead. */ - void scale (const value_type factor); + void scale (const value_type factor) DEAL_II_DEPRECATED; /** * Multiply each element of this diff --git a/deal.II/include/deal.II/lac/parallel_vector.h b/deal.II/include/deal.II/lac/parallel_vector.h index e1c53ceb32..69e2a7a33b 100644 --- a/deal.II/include/deal.II/lac/parallel_vector.h +++ b/deal.II/include/deal.II/lac/parallel_vector.h @@ -754,7 +754,7 @@ namespace parallel * operator *= and * operator /= instead. */ - void scale (const Number factor); + void scale (const Number factor) DEAL_II_DEPRECATED; /** diff --git a/deal.II/include/deal.II/lac/precondition_block.h b/deal.II/include/deal.II/lac/precondition_block.h index d9e4711c10..57d46f15fa 100644 --- a/deal.II/include/deal.II/lac/precondition_block.h +++ b/deal.II/include/deal.II/lac/precondition_block.h @@ -376,7 +376,7 @@ public: * The number of blocks of the * matrix. */ - unsigned int n_blocks() const; + unsigned int n_blocks() const DEAL_II_DEPRECATED; /** * Determine an estimate for the diff --git a/deal.II/include/deal.II/lac/relaxation_block.h b/deal.II/include/deal.II/lac/relaxation_block.h index dba6d906b6..068793f7b5 100644 --- a/deal.II/include/deal.II/lac/relaxation_block.h +++ b/deal.II/include/deal.II/lac/relaxation_block.h @@ -89,7 +89,7 @@ public: AdditionalData (const BlockList &block_list, const double relaxation = 1., const bool invert_diagonal = true, - const bool same_diagonal = false); + const bool same_diagonal = false) DEAL_II_DEPRECATED; /** diff --git a/deal.II/include/deal.II/lac/sparse_decomposition.h b/deal.II/include/deal.II/lac/sparse_decomposition.h index 19abf9986c..17e25c9bd7 100644 --- a/deal.II/include/deal.II/lac/sparse_decomposition.h +++ b/deal.II/include/deal.II/lac/sparse_decomposition.h @@ -153,7 +153,7 @@ protected: * compability. It will be removed * in later versions. */ - SparseLUDecomposition (const SparsityPattern &sparsity); + SparseLUDecomposition (const SparsityPattern &sparsity) DEAL_II_DEPRECATED; public: /** @@ -302,7 +302,7 @@ public: * * @deprecated */ - void reinit (const SparsityPattern &sparsity); + void reinit (const SparsityPattern &sparsity) DEAL_II_DEPRECATED; /** * This method is deprecated, @@ -314,7 +314,7 @@ public: */ template void decompose (const SparseMatrix &matrix, - const double strengthen_diagonal=0.); + const double strengthen_diagonal=0.) DEAL_II_DEPRECATED; /** * This method is deprecated, @@ -324,7 +324,7 @@ public: * * @deprecated */ - virtual bool is_decomposed () const; + virtual bool is_decomposed () const DEAL_II_DEPRECATED; /** * Return whether the object is diff --git a/deal.II/include/deal.II/lac/sparse_ilu.h b/deal.II/include/deal.II/lac/sparse_ilu.h index 7569b43260..900c857232 100644 --- a/deal.II/include/deal.II/lac/sparse_ilu.h +++ b/deal.II/include/deal.II/lac/sparse_ilu.h @@ -67,7 +67,7 @@ public: * backward compability. It will * be removed in later versions. */ - SparseILU (const SparsityPattern &sparsity); + SparseILU (const SparsityPattern &sparsity) DEAL_II_DEPRECATED; /** * Make @@ -122,7 +122,7 @@ public: */ template void decompose (const SparseMatrix &matrix, - const double strengthen_diagonal=0.); + const double strengthen_diagonal=0.) DEAL_II_DEPRECATED; /** * This method is deprecated, and @@ -132,7 +132,7 @@ public: */ template void apply_decomposition (Vector &dst, - const Vector &src) const; + const Vector &src) const DEAL_II_DEPRECATED; /** * Apply the incomplete decomposition, diff --git a/deal.II/include/deal.II/lac/sparse_matrix.h b/deal.II/include/deal.II/lac/sparse_matrix.h index f292e170e3..646fd428f5 100644 --- a/deal.II/include/deal.II/lac/sparse_matrix.h +++ b/deal.II/include/deal.II/lac/sparse_matrix.h @@ -1260,7 +1260,7 @@ public: * const_iterator instead! */ number raw_entry (const unsigned int row, - const unsigned int index) const; + const unsigned int index) const DEAL_II_DEPRECATED; /** * @internal @deprecated Use iterator or @@ -1285,7 +1285,7 @@ public: * avoid programs relying on * outdated information! */ - number global_entry (const unsigned int i) const; + number global_entry (const unsigned int i) const DEAL_II_DEPRECATED; /** * @internal @deprecated Use iterator or @@ -1295,7 +1295,7 @@ public: * access. You certainly know * what you do? */ - number &global_entry (const unsigned int i); + number &global_entry (const unsigned int i) DEAL_II_DEPRECATED; //@} /** diff --git a/deal.II/include/deal.II/lac/sparse_mic.h b/deal.II/include/deal.II/lac/sparse_mic.h index 3e82b16e99..f4ba0fbc2b 100644 --- a/deal.II/include/deal.II/lac/sparse_mic.h +++ b/deal.II/include/deal.II/lac/sparse_mic.h @@ -85,7 +85,7 @@ public: * compability. It will be * removed in later versions. */ - void reinit (const SparsityPattern &sparsity); + void reinit (const SparsityPattern &sparsity) DEAL_II_DEPRECATED; /** * Same as @p decompose. @@ -102,7 +102,7 @@ public: */ template void decompose (const SparseMatrix &matrix, - const double strengthen_diagonal=0.); + const double strengthen_diagonal=0.) DEAL_II_DEPRECATED; /** * Apply the incomplete decomposition, diff --git a/deal.II/include/deal.II/lac/sparsity_pattern.h b/deal.II/include/deal.II/lac/sparsity_pattern.h index 0eb8828807..e3a223b630 100644 --- a/deal.II/include/deal.II/lac/sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/sparsity_pattern.h @@ -1093,7 +1093,7 @@ public: * SparseMatrix::const_iterator */ unsigned int operator() (const unsigned int i, - const unsigned int j) const; + const unsigned int j) const DEAL_II_DEPRECATED; /** * This is the inverse operation @@ -1329,7 +1329,7 @@ public: * @p GridTools::partition_triangulation. */ void partition (const unsigned int n_partitions, - std::vector &partition_indices) const; + std::vector &partition_indices) const DEAL_II_DEPRECATED; /** @@ -1359,7 +1359,7 @@ public: * avoid programs relying on outdated * information! */ - inline const std::size_t *get_rowstart_indices () const; + inline const std::size_t *get_rowstart_indices () const DEAL_II_DEPRECATED; /** * @deprecated. Use @p row_length and @@ -1387,7 +1387,7 @@ public: * avoid programs relying on outdated * information! */ - inline const unsigned int *get_column_numbers () const; + inline const unsigned int *get_column_numbers () const DEAL_II_DEPRECATED; BOOST_SERIALIZATION_SPLIT_MEMBER() /** @addtogroup Exceptions diff --git a/deal.II/include/deal.II/lac/trilinos_block_vector.h b/deal.II/include/deal.II/lac/trilinos_block_vector.h index 1bea6bebaf..7db0f16042 100644 --- a/deal.II/include/deal.II/lac/trilinos_block_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_block_vector.h @@ -195,7 +195,7 @@ namespace TrilinosWrappers * distributed objects" for more * information. */ - void compress (const Epetra_CombineMode last_action); + void compress (const Epetra_CombineMode last_action) DEAL_II_DEPRECATED; /** * so it is not hidden diff --git a/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h b/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h index fd80a509dc..bff44724cd 100644 --- a/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h @@ -316,7 +316,7 @@ namespace TrilinosWrappers * distributed objects" for more * information. */ - void compress (const Epetra_CombineMode last_action); + void compress (const Epetra_CombineMode last_action) DEAL_II_DEPRECATED; /** * so it is not hidden diff --git a/deal.II/include/deal.II/lac/trilinos_vector_base.h b/deal.II/include/deal.II/lac/trilinos_vector_base.h index 76bee84634..e96c3e3085 100644 --- a/deal.II/include/deal.II/lac/trilinos_vector_base.h +++ b/deal.II/include/deal.II/lac/trilinos_vector_base.h @@ -351,7 +351,7 @@ namespace TrilinosWrappers /** * @deprecated */ - void compress (const Epetra_CombineMode last_action); + void compress (const Epetra_CombineMode last_action) DEAL_II_DEPRECATED; /** * Returns the state of the diff --git a/deal.II/include/deal.II/lac/vector.h b/deal.II/include/deal.II/lac/vector.h index f4a65a839a..bba0d25544 100644 --- a/deal.II/include/deal.II/lac/vector.h +++ b/deal.II/include/deal.II/lac/vector.h @@ -800,7 +800,7 @@ public: * operator *= and * operator /= instead. */ - void scale (const Number factor); + void scale (const Number factor) DEAL_II_DEPRECATED; /** diff --git a/deal.II/include/deal.II/multigrid/mg_matrix.h b/deal.II/include/deal.II/multigrid/mg_matrix.h index 4a7494b394..d9b5860b19 100644 --- a/deal.II/include/deal.II/multigrid/mg_matrix.h +++ b/deal.II/include/deal.II/multigrid/mg_matrix.h @@ -108,7 +108,7 @@ public: std::size_t memory_consumption () const; private: SmartPointer,MGMatrix > matrix; -}; +} DEAL_II_DEPRECATED; /** diff --git a/deal.II/include/deal.II/multigrid/mg_smoother.h b/deal.II/include/deal.II/multigrid/mg_smoother.h index af20b24341..0bb7332d13 100644 --- a/deal.II/include/deal.II/multigrid/mg_smoother.h +++ b/deal.II/include/deal.II/multigrid/mg_smoother.h @@ -71,7 +71,7 @@ public: const unsigned int steps = 1, const bool variable = false, const bool symmetric = false, - const bool transpose = false); + const bool transpose = false) DEAL_II_DEPRECATED; /** * Modify the number of smoothing diff --git a/deal.II/include/deal.II/multigrid/mg_tools.h b/deal.II/include/deal.II/multigrid/mg_tools.h index 4cce7ed888..78c79079e9 100644 --- a/deal.II/include/deal.II/multigrid/mg_tools.h +++ b/deal.II/include/deal.II/multigrid/mg_tools.h @@ -205,7 +205,7 @@ namespace MGTools void count_dofs_per_component (const MGDoFHandler &mg_dof, std::vector > &result, - std::vector target_component); + std::vector target_component) DEAL_II_DEPRECATED; /** * Generate a list of those diff --git a/deal.II/include/deal.II/multigrid/multigrid.h b/deal.II/include/deal.II/multigrid/multigrid.h index cf674c41f2..333110afe7 100644 --- a/deal.II/include/deal.II/multigrid/multigrid.h +++ b/deal.II/include/deal.II/multigrid/multigrid.h @@ -175,7 +175,7 @@ public: * level of this Multigrid * object. */ - void vmult(VECTOR &dst, const VECTOR &src) const; + void vmult(VECTOR &dst, const VECTOR &src) const DEAL_II_DEPRECATED; /** * @deprecated This function is @@ -193,7 +193,7 @@ public: * level of this Multigrid * object. */ - void vmult_add(VECTOR &dst, const VECTOR &src) const; + void vmult_add(VECTOR &dst, const VECTOR &src) const DEAL_II_DEPRECATED; /** * @deprecated Even worse than @@ -203,7 +203,7 @@ public: * objects relying on it can be * constructed. */ - void Tvmult(VECTOR &dst, const VECTOR &src) const; + void Tvmult(VECTOR &dst, const VECTOR &src) const DEAL_II_DEPRECATED; /** * @deprecated Even worse than @@ -213,7 +213,7 @@ public: * objects relying on it can be * constructed. */ - void Tvmult_add(VECTOR &dst, const VECTOR &src) const; + void Tvmult_add(VECTOR &dst, const VECTOR &src) const DEAL_II_DEPRECATED; /** * Set additional matrices to diff --git a/deal.II/include/deal.II/numerics/data_postprocessor.h b/deal.II/include/deal.II/numerics/data_postprocessor.h index 912b65fc7d..f8101e1634 100644 --- a/deal.II/include/deal.II/numerics/data_postprocessor.h +++ b/deal.II/include/deal.II/numerics/data_postprocessor.h @@ -124,7 +124,7 @@ public: const std::vector > &duh, const std::vector > &dduh, const std::vector > &normals, - std::vector > &computed_quantities) const; + std::vector > &computed_quantities) const DEAL_II_DEPRECATED; /** * This is the main function which actually @@ -182,7 +182,7 @@ public: const std::vector > > &duh, const std::vector > > &dduh, const std::vector > &normals, - std::vector > &computed_quantities) const; + std::vector > &computed_quantities) const DEAL_II_DEPRECATED; /** * Same as the diff --git a/deal.II/include/deal.II/numerics/point_value_history.h b/deal.II/include/deal.II/numerics/point_value_history.h index b8178902e9..0e7877caf1 100644 --- a/deal.II/include/deal.II/numerics/point_value_history.h +++ b/deal.II/include/deal.II/numerics/point_value_history.h @@ -554,7 +554,7 @@ public: * * @deprecated */ - Vector mark_locations(); + Vector mark_locations() DEAL_II_DEPRECATED; /** diff --git a/deal.II/include/deal.II/numerics/vector_tools.h b/deal.II/include/deal.II/numerics/vector_tools.h index ba3ef871d6..3c7cbf7a68 100644 --- a/deal.II/include/deal.II/numerics/vector_tools.h +++ b/deal.II/include/deal.II/numerics/vector_tools.h @@ -770,7 +770,7 @@ namespace VectorTools const types::boundary_id boundary_component, const Function &boundary_function, std::map &boundary_values, - const ComponentMask &component_mask = ComponentMask()); + const ComponentMask &component_mask = ComponentMask()) DEAL_II_DEPRECATED; /** * Calls the other @@ -911,7 +911,7 @@ namespace VectorTools const types::boundary_id boundary_component, const Function &boundary_function, ConstraintMatrix &constraints, - const ComponentMask &component_mask = ComponentMask()); + const ComponentMask &component_mask = ComponentMask()) DEAL_II_DEPRECATED; /** * Calls the other -- 2.39.5