]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Do not mark Epetra_Map interfaces as deprecated because it needs more work 1220/head
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Thu, 30 Jul 2015 12:01:59 +0000 (14:01 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Thu, 30 Jul 2015 12:01:59 +0000 (14:01 +0200)
doc/news/8.2.1-vs-8.3.0.h
include/deal.II/lac/trilinos_sparse_matrix.h

index 14cf7d191d45e7257808ac25d121c4a74710d4af..cda26e4e20e3f408c62ed2380726cf63a48d28a2 100644 (file)
@@ -394,8 +394,6 @@ inconvenience this causes.
 
 <ol>
   <li> New: IndexSet now can be constructed using Epetra_Map.
-  All constructors of TrilinosWrappers::SparseMatrix which use Epetra_Map
-  were marked deprecated. 
   <br>
   (Luca Heltai, 2015/07/25)
   </li>
index 9d7a7a99503f684d073f60cb9966e900dc62ebd8..43cfdcf6bb1589ba2a0e486199e65b2fcb5521c2 100644 (file)
@@ -662,7 +662,7 @@ namespace TrilinosWrappers
      * the compress() step).
      */
     SparseMatrix (const Epetra_Map  &parallel_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.
@@ -672,7 +672,7 @@ namespace TrilinosWrappers
      * respective SparseMatrix::reinit call considerably faster.
      */
     SparseMatrix (const Epetra_Map                &parallel_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
@@ -692,7 +692,7 @@ namespace TrilinosWrappers
      */
     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
@@ -710,7 +710,7 @@ namespace TrilinosWrappers
      */
     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
@@ -739,7 +739,7 @@ namespace TrilinosWrappers
     template<typename SparsityType>
     void reinit (const Epetra_Map    &parallel_partitioning,
                  const SparsityType  &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,
@@ -757,7 +757,7 @@ namespace TrilinosWrappers
     void reinit (const Epetra_Map    &row_parallel_partitioning,
                  const Epetra_Map    &col_parallel_partitioning,
                  const SparsityType  &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
@@ -780,7 +780,7 @@ namespace TrilinosWrappers
                  const ::dealii::SparseMatrix<number> &dealii_sparse_matrix,
                  const double                          drop_tolerance=1e-13,
                  const bool                            copy_values=true,
-                 const ::dealii::SparsityPattern      *use_this_sparsity=0) DEAL_II_DEPRECATED;
+                 const ::dealii::SparsityPattern      *use_this_sparsity=0);
 
     /**
      * This function is similar to the other initialization function with
@@ -801,7 +801,7 @@ namespace TrilinosWrappers
                  const ::dealii::SparseMatrix<number>  &dealii_sparse_matrix,
                  const double                           drop_tolerance=1e-13,
                  const bool                             copy_values=true,
-                 const ::dealii::SparsityPattern      *use_this_sparsity=0) DEAL_II_DEPRECATED;
+                 const ::dealii::SparsityPattern      *use_this_sparsity=0);
 //@}
     /**
      * @name Constructors and initialization using an IndexSet description
@@ -1669,7 +1669,7 @@ namespace TrilinosWrappers
      * sets the partitioning of the domain space of this matrix, i.e., the
      * partitioning of the vectors this matrix has to be multiplied with.
      */
-    const Epetra_Map &domain_partitioner ()  const DEAL_II_DEPRECATED;
+    const Epetra_Map &domain_partitioner ()  const;
 
     /**
      * Return a const reference to the underlying Trilinos Epetra_Map that
@@ -1677,14 +1677,14 @@ namespace TrilinosWrappers
      * partitioning of the vectors that are result from matrix-vector
      * products.
      */
-    const Epetra_Map &range_partitioner () const DEAL_II_DEPRECATED;
+    const Epetra_Map &range_partitioner () const;
 
     /**
      * Return a const reference to the underlying Trilinos Epetra_Map that
      * sets the partitioning of the matrix rows. Equal to the partitioning of
      * the range.
      */
-    const Epetra_Map &row_partitioner () const DEAL_II_DEPRECATED;
+    const Epetra_Map &row_partitioner () const;
 
     /**
      * Return a const reference to the underlying Trilinos Epetra_Map that
@@ -1692,7 +1692,7 @@ namespace TrilinosWrappers
      * equal to the partitioner Epetra_Map for the domain because of overlap
      * in the matrix.
      */
-    const Epetra_Map &col_partitioner () const DEAL_II_DEPRECATED;
+    const Epetra_Map &col_partitioner () const;
 //@}
 
     /**

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.