]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Add DEAL_II_DEPRECATED attributes to deprecated fucntions and classes
authormaier <maier@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 26 Nov 2012 14:37:12 +0000 (14:37 +0000)
committermaier <maier@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 26 Nov 2012 14:37:12 +0000 (14:37 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_deprecated@27686 0785d39b-7218-0410-832d-ea1e28bc413d

39 files changed:
deal.II/include/deal.II/base/logstream.h
deal.II/include/deal.II/base/mg_level_object.h
deal.II/include/deal.II/base/table.h
deal.II/include/deal.II/base/thread_management.h
deal.II/include/deal.II/base/types.h
deal.II/include/deal.II/base/utilities.h
deal.II/include/deal.II/dofs/dof_handler.h
deal.II/include/deal.II/dofs/dof_renumbering.h
deal.II/include/deal.II/dofs/dof_tools.h
deal.II/include/deal.II/fe/fe_base.h
deal.II/include/deal.II/fe/fe_values.h
deal.II/include/deal.II/fe/mapping.h
deal.II/include/deal.II/grid/grid_tools.h
deal.II/include/deal.II/grid/tria.h
deal.II/include/deal.II/lac/block_list.h
deal.II/include/deal.II/lac/block_matrix_array.h
deal.II/include/deal.II/lac/block_sparsity_pattern.h
deal.II/include/deal.II/lac/block_vector.h
deal.II/include/deal.II/lac/block_vector_base.h
deal.II/include/deal.II/lac/parallel_block_vector.h
deal.II/include/deal.II/lac/parallel_vector.h
deal.II/include/deal.II/lac/precondition_block.h
deal.II/include/deal.II/lac/relaxation_block.h
deal.II/include/deal.II/lac/sparse_decomposition.h
deal.II/include/deal.II/lac/sparse_ilu.h
deal.II/include/deal.II/lac/sparse_matrix.h
deal.II/include/deal.II/lac/sparse_mic.h
deal.II/include/deal.II/lac/sparsity_pattern.h
deal.II/include/deal.II/lac/trilinos_block_vector.h
deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h
deal.II/include/deal.II/lac/trilinos_vector_base.h
deal.II/include/deal.II/lac/vector.h
deal.II/include/deal.II/multigrid/mg_matrix.h
deal.II/include/deal.II/multigrid/mg_smoother.h
deal.II/include/deal.II/multigrid/mg_tools.h
deal.II/include/deal.II/multigrid/multigrid.h
deal.II/include/deal.II/numerics/data_postprocessor.h
deal.II/include/deal.II/numerics/point_value_history.h
deal.II/include/deal.II/numerics/vector_tools.h

index cb50979e3807875c1617432f729060d9f16054d9..83a98105fd90aa708753eeee51d8cce9a488f8f5 100644 (file)
@@ -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
index 89dae1ab3047a8ab8016c242b11eb13eb19ce401..eca7a5f5343cd5186307fd6039bd408976706759 100644 (file)
@@ -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.
index fc28f61f8285efe84ead4106da70535442d09493..607eb1a7ebbe8ed08b65db0e631429e5bf5577b3 100644 (file)
@@ -700,7 +700,7 @@ protected:
    * cast from const), otherwise,
    * keep away!
    */
-  typename std::vector<T>::const_pointer data () const;
+  typename std::vector<T>::const_pointer data () const DEAL_II_DEPRECATED;
 
 protected:
   /**
index a99fba01466efc0e7bc79167cec1613c2768582f..28092d867f05659a57941a9c096725e5440fcefa 100644 (file)
@@ -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
   /**
index e6358656402e2959c9031a95cb4673d470b36346..de4956585ebe93d8c2f01dc71461bcfdcc89d8f3 100644 (file)
@@ -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<subdomain_id>(-1);
+  const unsigned int invalid_subdomain_id DEAL_II_DEPRECATED = static_cast<subdomain_id>(-1);
 
   /**
    * @deprecated Use numbers::artificial_subdomain_id
    */
-  const unsigned int artificial_subdomain_id = static_cast<subdomain_id>(-2);
+  const unsigned int artificial_subdomain_id DEAL_II_DEPRECATED = static_cast<subdomain_id>(-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<global_dof_index>(-1);
+  const global_dof_index invalid_dof_index DEAL_II_DEPRECATED = static_cast<global_dof_index>(-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;
 
 }
 
index 355d46a74d042ee55803cb3d2706e0b3e79ed073..828f23ce04b59f25f51eb1662bc9bb179b261b3c 100644 (file)
@@ -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.
index 707eaedf8ee9ea69cd5577eda7ad80a14dae55db..86973e95063cc431910d3b1d0c701043f422c29f 100644 (file)
@@ -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;
 
   /*--------------------------------------*/
 
index d5f789cf8950dd730eae2820977258f6abdb4a81..3326700325438ba0b3a45f057f712c0e6d7d8fb1 100644 (file)
@@ -962,7 +962,7 @@ namespace DoFRenumbering
   template <class DH>
   void
   cell_wise_dg (DH &dof_handler,
-                const std::vector<typename DH::cell_iterator> &cell_order);
+                const std::vector<typename DH::cell_iterator> &cell_order) DEAL_II_DEPRECATED;
 
   /**
    * Computes the renumbering
@@ -1019,7 +1019,7 @@ namespace DoFRenumbering
   void
   cell_wise_dg (MGDoFHandler<dim>   &dof_handler,
                 const unsigned int   level,
-                const std::vector<typename MGDoFHandler<dim>::cell_iterator> &cell_order);
+                const std::vector<typename MGDoFHandler<dim>::cell_iterator> &cell_order) DEAL_II_DEPRECATED;
 
   /**
    * Computes the renumbering
@@ -1120,7 +1120,7 @@ namespace DoFRenumbering
   template <class DH, int dim>
   void
   downstream_dg (DH               &dof_handler,
-                 const Point<dim> &direction);
+                 const Point<dim> &direction) DEAL_II_DEPRECATED;
 
   /**
    * Cell-wise downstream numbering
@@ -1144,7 +1144,7 @@ namespace DoFRenumbering
   void
   downstream_dg (MGDoFHandler<dim> &dof_handler,
                  const unsigned int level,
-                 const Point<dim>  &direction);
+                 const Point<dim>  &direction) DEAL_II_DEPRECATED;
 
   /**
    * @deprecated The new function
@@ -1166,7 +1166,7 @@ namespace DoFRenumbering
   void
   compute_downstream_dg (std::vector<unsigned int> &new_dof_indices,
                          const DH                  &dof_handler,
-                         const Point<dim>          &direction);
+                         const Point<dim>          &direction) DEAL_II_DEPRECATED;
 
   /**
    * Computes the renumbering
@@ -1194,7 +1194,7 @@ namespace DoFRenumbering
   compute_downstream_dg (std::vector<unsigned int> &new_dof_indices,
                          std::vector<unsigned int> &reverse,
                          const DH                  &dof_handler,
-                         const Point<dim>          &direction);
+                         const Point<dim>          &direction) DEAL_II_DEPRECATED;
 
   /**
    * Computes the renumbering
@@ -1224,7 +1224,7 @@ namespace DoFRenumbering
                          std::vector<unsigned int> &reverse,
                          const MGDoFHandler<dim>   &dof_handler,
                          const unsigned int         level,
-                         const Point<dim>          &direction);
+                         const Point<dim>          &direction) DEAL_II_DEPRECATED;
 
   /**
    * Cell-wise clockwise numbering.
index 85c056453f470bcfb175fe781a36a125f44b514d..4489a4eff149caec924519955553fdd0cf733dee 100644 (file)
@@ -677,7 +677,7 @@ namespace DoFTools
   void
   make_sparsity_pattern (const DH                              &dof,
                          const std::vector<std::vector<bool> > &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<dim,spacedim>     &dof_handler,
                             std::vector<unsigned int> &dofs_per_component,
-                            std::vector<unsigned int>  target_component);
+                            std::vector<unsigned int>  target_component) DEAL_II_DEPRECATED;
 
   /**
    * This function can be used when
index 0fb62efe6566d3a44751bb267956b1d18b736a1b..f46cc123036641dff4eb0084c02588fc7d0ca828 100644 (file)
@@ -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.
index 81a8e17349b935dc94084c5591e135501a162890..801aa33fd5ee40ce3cfc563b60fded69aeba70f6 100644 (file)
@@ -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 <class InputVector>
   void get_function_grads (const InputVector      &fe_function,
-                           std::vector<Tensor<1,spacedim> > &gradients) const;
+                           std::vector<Tensor<1,spacedim> > &gradients) const DEAL_II_DEPRECATED;
 
   /**
    * @deprecated Use
@@ -2295,7 +2295,7 @@ public:
    */
   template <class InputVector>
   void get_function_grads (const InputVector               &fe_function,
-                           std::vector<std::vector<Tensor<1,spacedim> > > &gradients) const;
+                           std::vector<std::vector<Tensor<1,spacedim> > > &gradients) const DEAL_II_DEPRECATED;
 
   /**
    * @deprecated Use
@@ -2304,7 +2304,7 @@ public:
   template <class InputVector>
   void get_function_grads (const InputVector &fe_function,
                            const VectorSlice<const std::vector<unsigned int> > &indices,
-                           std::vector<Tensor<1,spacedim> > &gradients) const;
+                           std::vector<Tensor<1,spacedim> > &gradients) const DEAL_II_DEPRECATED;
 
   /**
    * @deprecated Use
@@ -2314,7 +2314,7 @@ public:
   void get_function_grads (const InputVector &fe_function,
                            const VectorSlice<const std::vector<unsigned int> > &indices,
                            std::vector<std::vector<Tensor<1,spacedim> > > &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 <class InputVector>
   void
   get_function_2nd_derivatives (const InputVector &,
-                                std::vector<Tensor<2,spacedim> > &) const;
+                                std::vector<Tensor<2,spacedim> > &) const DEAL_II_DEPRECATED;
 
   /**
    * @deprecated Wrapper for get_function_hessians()
@@ -2475,7 +2475,7 @@ public:
   void
   get_function_2nd_derivatives (const InputVector &,
                                 std::vector<std::vector<Tensor<2,spacedim> > > &,
-                                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<spacedim> &cell_normal_vector (const unsigned int i) const;
+  const Point<spacedim> &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<Point<spacedim> > &get_cell_normal_vectors () const;
+  const std::vector<Point<spacedim> > &get_cell_normal_vectors () const DEAL_II_DEPRECATED;
 
   //@}
 
index 73a327eded942ba6d4f6ecb8adae755a6112264a..3a5dc6077707aad3792e623761a82daf4ac940a3 100644 (file)
@@ -609,7 +609,7 @@ public:
   transform_covariant (const VectorSlice<const std::vector<Tensor<1,dim> > > input,
                        const unsigned int                                    offset,
                        VectorSlice<std::vector<Tensor<1,spacedim> > >        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<const std::vector<DerivativeForm<1, dim ,spacedim> > > input,
                        const unsigned int                 offset,
                        VectorSlice<std::vector<Tensor<2,spacedim> > >      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<const std::vector<Tensor<1,dim> > > input,
                            const unsigned int                 offset,
                            VectorSlice<std::vector<Tensor<1,spacedim> > >      output,
-                           const typename Mapping<dim,spacedim>::InternalDataBase &internal) const;
+                           const typename Mapping<dim,spacedim>::InternalDataBase &internal) const DEAL_II_DEPRECATED;
 
   /**
    * @deprecated Use transform() instead.
@@ -637,7 +637,7 @@ public:
   transform_contravariant (const VectorSlice<const std::vector<DerivativeForm<1, dim,spacedim> > > input,
                            const unsigned int                 offset,
                            const VectorSlice<std::vector<Tensor<2,spacedim> > > output,
-                           const typename Mapping<dim,spacedim>::InternalDataBase &internal) const;
+                           const typename Mapping<dim,spacedim>::InternalDataBase &internal) const DEAL_II_DEPRECATED;
 
   /**
    * The transformed (generalized)
index 774e5a32ccbdf61f4ed91dbeb7e957888f9474a9..bea556bdafe603263f1d67edfa9a439495f109f3 100644 (file)
@@ -298,7 +298,7 @@ namespace GridTools
   template<int dim, template <int, int> class Container, int spacedim>
   std::vector<typename Container<dim,spacedim>::active_cell_iterator>
   find_cells_adjacent_to_vertex (const Container<dim,spacedim> &container,
-                                 const unsigned int    vertex);
+                                 const unsigned int    vertex) DEAL_II_DEPRECATED;
 
 
   /**
index e47add785f49c7629773d9ebbba7b9f60ca934c9..86eace851c61a0f44560a5dc025882a59596b11e 100644 (file)
@@ -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<dim, spacedim> &tria);
+    pre_refinement_notification (const Triangulation<dim, spacedim> &tria) DEAL_II_DEPRECATED;
 
     /**
      * After refinement is actually
@@ -1511,7 +1511,7 @@ public:
      */
     virtual
     void
-    post_refinement_notification (const Triangulation<dim, spacedim> &tria);
+    post_refinement_notification (const Triangulation<dim, spacedim> &tria) DEAL_II_DEPRECATED;
 
     /**
      * At the end of a call to
@@ -1537,7 +1537,7 @@ public:
     virtual
     void
     copy_notification (const Triangulation<dim, spacedim> &old_tria,
-                       const Triangulation<dim, spacedim> &new_tria);
+                       const Triangulation<dim, spacedim> &new_tria) DEAL_II_DEPRECATED;
 
     /**
      * At the end of a call to
@@ -1559,8 +1559,9 @@ public:
      */
     virtual
     void
-    create_notification (const Triangulation<dim, spacedim> &tria);
-  };
+    create_notification (const Triangulation<dim, spacedim> &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
index d40c9c9814c051d40e9c337419bc87e8a28f6883..04c312d8065782e63e8ffd0422c0b55c7ef9242c 100644 (file)
@@ -135,7 +135,7 @@ public:
   template <typename ITERATOR>
   void initialize_mg(unsigned int n_blocks,
                      const ITERATOR begin,
-                     const typename identity<ITERATOR>::type end);
+                     const typename identity<ITERATOR>::type end) DEAL_II_DEPRECATED;
 
   /**
    * @deprecated This function will
@@ -173,7 +173,7 @@ public:
                   const ITERATOR begin,
                   const typename identity<ITERATOR>::type end,
                   const std::vector<bool> &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<ITERATOR>::type end,
                      const std::vector<bool> &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<ITERATOR>::type end,
                                     const std::vector<bool> &selected_dofs = std::vector<bool>(),
-                                    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<ITERATOR>::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 <int dim, typename ITERATOR>
   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<block_container> index_sets;
-};
+} DEAL_II_DEPRECATED;
 
 
 inline
index 028ead966e59ee517a3d71336e1b13372d221821..c9eeb5b8d90d290b62dfe3ce88f8759a9598d331 100644 (file)
@@ -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<Vector<number> > &mem);
+                    VectorMemory<Vector<number> > &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<Vector<number> > &mem);
+                   VectorMemory<Vector<number> > &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<Vector<number> > &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<Vector<number> > &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.
index ef700e921881814e65f671d717411514db9bee60..9b412967b02bfb639c38a88c74319ab9f0e70dc1 100644 (file)
@@ -745,7 +745,7 @@ public:
  *
  * @deprecated
  */
-typedef BlockCompressedSparsityPattern CompressedBlockSparsityPattern;
+typedef BlockCompressedSparsityPattern CompressedBlockSparsityPattern DEAL_II_DEPRECATED;
 
 
 
index c090a14a517195f8b405f0e67dd5d93148334120..2ce6364d1b6b632dff6356138ac425abf500ffdf 100644 (file)
@@ -368,7 +368,7 @@ public:
    * @deprecated Use <tt>operator*=</tt>
    * instead.
    */
-  void scale (const value_type factor);
+  void scale (const value_type factor) DEAL_II_DEPRECATED;
 
   /**
    * Multiply each element of this
index a36f8daf8c4a9e98ff1595787c56e4066eb20cc5..28d6efc9bd45b19628a1d8f5419835f1db8c4111 100644 (file)
@@ -816,7 +816,7 @@ public:
    * versions
    */
   const BlockIndices &
-  get_block_indices () const;
+  get_block_indices () const DEAL_II_DEPRECATED;
 
   /**
    * Number of blocks.
index 76c81f708a737bdb7f15665e6fa480ec12bd5a4c..221570efd034cc1c7492677538529a795e74c56a 100644 (file)
@@ -284,7 +284,7 @@ namespace parallel
        * @deprecated Use <tt>operator*=</tt>
        * instead.
        */
-      void scale (const value_type factor);
+      void scale (const value_type factor) DEAL_II_DEPRECATED;
 
       /**
        * Multiply each element of this
index e1c53ceb3298a97cb48968af8c15f683a1d713ec..69e2a7a33b53743ee128642e727e4d7987db3afd 100644 (file)
@@ -754,7 +754,7 @@ namespace parallel
        * <tt>operator *=</tt> and
        * <tt>operator /=</tt> instead.
        */
-      void scale (const Number factor);
+      void scale (const Number factor) DEAL_II_DEPRECATED;
 
 
       /**
index d9e4711c10760dd8c111cf494c2965dfbdfed9ea..57d46f15fa43641e4b98fb2231f3b03da5aea49c 100644 (file)
@@ -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
index dba6d906b664734f5965817a365f48d02a6b689e..068793f7b5e8d9586ab1ec2712d2c1685bb81ab6 100644 (file)
@@ -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;
 
 
     /**
index 19abf9986c07df5f545c4c3e2154856bf79ee604..17e25c9bd79ac066bdd2811ad53e7910ae756c31 100644 (file)
@@ -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 <typename somenumber>
   void decompose (const SparseMatrix<somenumber> &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
index 7569b432609d8c07000899da9f6fbf3b9aab5207..900c85723253644bfbf598c609a18f6defd3deb9 100644 (file)
@@ -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 <typename somenumber>
   void decompose (const SparseMatrix<somenumber> &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 <typename somenumber>
   void apply_decomposition (Vector<somenumber>       &dst,
-                            const Vector<somenumber> &src) const;
+                            const Vector<somenumber> &src) const DEAL_II_DEPRECATED;
 
   /**
    * Apply the incomplete decomposition,
index f292e170e3872dd1f913086e6639343d22c78fc7..646fd428f50d52e7d70550f00c8410c591b388bd 100644 (file)
@@ -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;
 
 //@}
   /**
index 3e82b16e99ce8690137a4ba2d14a9872512b012a..f4ba0fbc2bb485941d35abdc0929d2dcbe8efd77 100644 (file)
@@ -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 <typename somenumber>
   void decompose (const SparseMatrix<somenumber> &matrix,
-                  const double                   strengthen_diagonal=0.);
+                  const double                   strengthen_diagonal=0.) DEAL_II_DEPRECATED;
 
   /**
    * Apply the incomplete decomposition,
index 0eb882880764b2fe639310ad2c8cf7dcbc7d89da..e3a223b6305428cb8beac8043a44eb5f35e3e2ea 100644 (file)
@@ -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<unsigned int> &partition_indices) const;
+                  std::vector<unsigned int> &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
index 1bea6bebaf33e5d9e38a91735e0522169d92bb75..7db0f16042bfe230664fcb8675ee9bc66f5d9d11 100644 (file)
@@ -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
index fd80a509dc01d223232f1f43f2ce378da69f2ae1..bff44724cd7bc86d105e5512b2c911765c51f58a 100644 (file)
@@ -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
index 76bee846341d47a6318c303703e14627ecdfdaa0..e96c3e3085086ddba6ac67b4fc02e994782dfc93 100644 (file)
@@ -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
index f4a65a839a96a52f010ebf5874965c4ace6fe22d..bba0d255442aa758ee1ae04d5d86aed497937f8a 100644 (file)
@@ -800,7 +800,7 @@ public:
    * <tt>operator *=</tt> and
    * <tt>operator /=</tt> instead.
    */
-  void scale (const Number factor);
+  void scale (const Number factor) DEAL_II_DEPRECATED;
 
 
   /**
index 4a7494b394ede2ba0afe584078b0d15ec79e50af..d9b5860b19ac2da052dc549b2c060b0511099ff8 100644 (file)
@@ -108,7 +108,7 @@ public:
   std::size_t memory_consumption () const;
 private:
   SmartPointer<MGLevelObject<MATRIX>,MGMatrix<MATRIX,VECTOR> > matrix;
-};
+} DEAL_II_DEPRECATED;
 
 
 /**
index af20b243417de3cb3d6c1c7f486101520ec9ebac..0bb7332d133637cebadb3baf31af75a309f5e5b7 100644 (file)
@@ -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
index 4cce7ed8887bf6ee7b7c9030da17562fd745fa27..78c79079e964cf40201dfe7f896309bd7e4e8b41 100644 (file)
@@ -205,7 +205,7 @@ namespace MGTools
   void
   count_dofs_per_component (const MGDoFHandler<dim,spacedim> &mg_dof,
                             std::vector<std::vector<unsigned int> > &result,
-                            std::vector<unsigned int> target_component);
+                            std::vector<unsigned int> target_component) DEAL_II_DEPRECATED;
 
   /**
    * Generate a list of those
index cf674c41f25629838809606150593bfb9b9bb7ba..333110afe7d41410ecdb94a5df09d2273bf55984 100644 (file)
@@ -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
index 912b65fc7d58811d32ea66cc6501f0668b3e25fc..f8101e16343342f2952f2d92de4f8f5a409756a7 100644 (file)
@@ -124,7 +124,7 @@ public:
                                      const std::vector<Tensor<1,dim> > &duh,
                                      const std::vector<Tensor<2,dim> > &dduh,
                                      const std::vector<Point<dim> >    &normals,
-                                     std::vector<Vector<double> >      &computed_quantities) const;
+                                     std::vector<Vector<double> >      &computed_quantities) const DEAL_II_DEPRECATED;
 
   /**
    * This is the main function which actually
@@ -182,7 +182,7 @@ public:
                                      const std::vector<std::vector<Tensor<1,dim> > > &duh,
                                      const std::vector<std::vector<Tensor<2,dim> > > &dduh,
                                      const std::vector<Point<dim> >                  &normals,
-                                     std::vector<Vector<double> >                    &computed_quantities) const;
+                                     std::vector<Vector<double> >                    &computed_quantities) const DEAL_II_DEPRECATED;
 
   /**
    * Same as the
index b8178902e98bfd2270a71f2177dabd83396bdad4..0e7877caf16e8149fc1376131976881d0c5dfd3b 100644 (file)
@@ -554,7 +554,7 @@ public:
   *
   * @deprecated
    */
-  Vector<double> mark_locations();
+  Vector<double> mark_locations() DEAL_II_DEPRECATED;
 
 
   /**
index ba3ef871d6629661a5d9310b1da66bedf63d6c91..3c7cbf7a6819de18a773d3d9b5653dbcdd97ec9b 100644 (file)
@@ -770,7 +770,7 @@ namespace VectorTools
                                const types::boundary_id            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
                                std::map<unsigned int,double> &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<DH::space_dimension> &boundary_function,
                                ConstraintMatrix                    &constraints,
-                               const ComponentMask             &component_mask = ComponentMask());
+                               const ComponentMask             &component_mask = ComponentMask()) DEAL_II_DEPRECATED;
 
   /**
    * Calls the other

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.