]> https://gitweb.dealii.org/ - dealii.git/commitdiff
List deprecated interfaces also in the doxygen documentation 1227/head
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Fri, 31 Jul 2015 06:58:37 +0000 (08:58 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Fri, 31 Jul 2015 06:58:37 +0000 (08:58 +0200)
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h

index e07bdab617fae14fc609e2cd602b37bf7fc2b173..c7f916bbc3c26e5d8a00d405c7ccc77c0200a7f1 100644 (file)
@@ -653,6 +653,8 @@ namespace TrilinosWrappers
      * the degrees of freedom on the individual block.  This function is
      * equivalent to calling the second constructor with the length of the
      * mapping vector and then entering the index values.
+     *
+     * @deprecated Use the respective method with IndexSet arguments instead.
      */
     BlockSparsityPattern (const std::vector<Epetra_Map> &parallel_partitioning) DEAL_II_DEPRECATED;
 
@@ -698,6 +700,8 @@ namespace TrilinosWrappers
      * Resize the matrix to a square tensor product of matrices with parallel
      * distribution according to the specifications in the array of
      * Epetra_Maps.
+     *
+     * @deprecated Use the respective method with IndexSet arguments instead.
      */
     void reinit (const std::vector<Epetra_Map> &parallel_partitioning) DEAL_II_DEPRECATED;
 
index 0db7629e8f33be95cd849d050fc15ddb02461634..3f9cb6e5a7a82a8e92a833dd14c189607542a69b 100644 (file)
@@ -182,6 +182,8 @@ namespace TrilinosWrappers
      * matrix and the entries stored therein. It uses a threshold to copy only
      * elements whose modulus is larger than the threshold (so zeros in the
      * deal.II matrix can be filtered away).
+     *
+     * @deprecated Use the respective method with IndexSet arguments instead.
      */
     void reinit (const std::vector<Epetra_Map>             &input_maps,
                  const ::dealii::BlockSparseMatrix<double> &deal_ii_sparse_matrix,
@@ -228,6 +230,9 @@ namespace TrilinosWrappers
      * partitioning of the domain space of this block matrix, i.e., the
      * partitioning of the individual block vectors this matrix has to be
      * multiplied with.
+     *
+     * @deprecated Use the methods of the individual matrices based on
+     * IndexSet arguments.
      */
     std::vector<Epetra_Map> domain_partitioner () const DEAL_II_DEPRECATED;
 
@@ -236,6 +241,9 @@ namespace TrilinosWrappers
      * partitioning of the range space of this block matrix, i.e., the
      * partitioning of the individual block vectors that are the result from
      * matrix-vector products.
+     *
+     * @deprecated Use the methods of the individual matrices based on
+     * IndexSet arguments.
      */
     std::vector<Epetra_Map> range_partitioner () const DEAL_II_DEPRECATED;
 
index 1096be7f0843fb69c744d16eb5e5c248c9c9ba06..ee6390f61843ee17dd383a1a90f7b007a0c7f102 100644 (file)
@@ -660,6 +660,8 @@ namespace TrilinosWrappers
      * However, there is no effect in the performance of matrix-vector
      * products, since Trilinos reorganizes the matrix memory prior to use (in
      * the compress() step).
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     SparseMatrix (const Epetra_Map  &parallel_partitioning,
                   const size_type    n_max_entries_per_row = 0) DEAL_II_DEPRECATED;
@@ -670,6 +672,8 @@ namespace TrilinosWrappers
      * case, we can already allocate the right amount of memory, which makes
      * the creation process including the insertion of nonzero elements by the
      * respective SparseMatrix::reinit call considerably faster.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     SparseMatrix (const Epetra_Map                &parallel_partitioning,
                   const std::vector<unsigned int> &n_entries_per_row) DEAL_II_DEPRECATED;
@@ -689,6 +693,8 @@ namespace TrilinosWrappers
      *
      * The integer input @p n_max_entries_per_row defines the number of
      * columns entries per row that will be allocated.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     SparseMatrix (const Epetra_Map &row_parallel_partitioning,
                   const Epetra_Map &col_parallel_partitioning,
@@ -707,6 +713,8 @@ namespace TrilinosWrappers
      * rather, all column elements of a row are stored on the same processor
      * in any case. The vector <tt>n_entries_per_row</tt> specifies the number
      * of entries in each row of the newly generated matrix.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     SparseMatrix (const Epetra_Map                &row_parallel_partitioning,
                   const Epetra_Map                &col_parallel_partitioning,
@@ -735,6 +743,8 @@ namespace TrilinosWrappers
      *
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     template<typename SparsityType>
     void reinit (const Epetra_Map    &parallel_partitioning,
@@ -752,6 +762,8 @@ namespace TrilinosWrappers
      *
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     template<typename SparsityType>
     void reinit (const Epetra_Map    &row_parallel_partitioning,
@@ -774,6 +786,8 @@ namespace TrilinosWrappers
      *
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     template <typename number>
     void reinit (const Epetra_Map                     &parallel_partitioning,
@@ -794,6 +808,8 @@ namespace TrilinosWrappers
      *
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     template <typename number>
     void reinit (const Epetra_Map                      &row_parallel_partitioning,
@@ -1668,6 +1684,8 @@ namespace TrilinosWrappers
      * Return a const reference to the underlying Trilinos Epetra_Map that
      * sets the partitioning of the domain space of this matrix, i.e., the
      * partitioning of the vectors this matrix has to be multiplied with.
+     *
+     * @deprecated Use locally_owned_domain_indices() instead.
      */
     const Epetra_Map &domain_partitioner ()  const DEAL_II_DEPRECATED;
 
@@ -1676,6 +1694,8 @@ namespace TrilinosWrappers
      * sets the partitioning of the range space of this matrix, i.e., the
      * partitioning of the vectors that are result from matrix-vector
      * products.
+     *
+     * @deprecated Use locally_owned_range_indices() instead.
      */
     const Epetra_Map &range_partitioner () const DEAL_II_DEPRECATED;
 
@@ -1683,6 +1703,8 @@ namespace TrilinosWrappers
      * 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.
+     *
+     * @deprecated Use locally_owned_range_indices() instead.
      */
     const Epetra_Map &row_partitioner () const DEAL_II_DEPRECATED;
 
@@ -1691,6 +1713,9 @@ namespace TrilinosWrappers
      * sets the partitioning of the matrix columns. This is in general not
      * equal to the partitioner Epetra_Map for the domain because of overlap
      * in the matrix.
+     *
+     * @deprecated Usually not necessary. If desired, access it via the
+     * Epetra_CrsMatrix.
      */
     const Epetra_Map &col_partitioner () const DEAL_II_DEPRECATED;
 //@}
index e0287e30429fba34b34a3648505eff492505ba37..9474c8b465976b5bb8d6c1fd00c62c8726866b60 100644 (file)
@@ -421,6 +421,8 @@ namespace TrilinosWrappers
      * advantageous to provide good estimates here since a good value will
      * avoid repeated allocation of memory, which considerably increases the
      * performance when creating the sparsity pattern.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     SparsityPattern (const Epetra_Map &parallel_partitioning,
                      const size_type   n_entries_per_row = 0) DEAL_II_DEPRECATED;
@@ -434,6 +436,8 @@ namespace TrilinosWrappers
      * since knowing the number of entries in each row is usually connected to
      * knowing the indices of nonzero entries, which the sparsity pattern is
      * designed to describe.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     SparsityPattern (const Epetra_Map             &parallel_partitioning,
                      const std::vector<size_type> &n_entries_per_row) DEAL_II_DEPRECATED;
@@ -453,6 +457,8 @@ namespace TrilinosWrappers
      *
      * The number of columns entries per row is specified as the maximum
      * number of entries argument.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     SparsityPattern (const Epetra_Map   &row_parallel_partitioning,
                      const Epetra_Map   &col_parallel_partitioning,
@@ -468,6 +474,8 @@ namespace TrilinosWrappers
      * themselves &ndash; rather, all column elements of a row are stored on
      * the same processor. The vector <tt>n_entries_per_row</tt> specifies the
      * number of entries in each row of the newly generated matrix.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     SparsityPattern (const Epetra_Map             &row_parallel_partitioning,
                      const Epetra_Map             &col_parallel_partitioning,
@@ -486,6 +494,8 @@ namespace TrilinosWrappers
      * This function does not create any entries by itself, but provides the
      * correct data structures that can be used by the respective add()
      * function.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     void
     reinit (const Epetra_Map &parallel_partitioning,
@@ -500,6 +510,8 @@ namespace TrilinosWrappers
      * number of entries in each row is usually connected to knowing the
      * indices of nonzero entries, which the sparsity pattern is designed to
      * describe.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     void
     reinit (const Epetra_Map             &parallel_partitioning,
@@ -520,6 +532,8 @@ namespace TrilinosWrappers
      *
      * The number of columns entries per row is specified by the argument
      * <tt>n_entries_per_row</tt>.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     void
     reinit (const Epetra_Map   &row_parallel_partitioning,
@@ -536,6 +550,8 @@ namespace TrilinosWrappers
      * themselves &ndash; rather, all column elements of a row are stored on
      * the same processor. The vector <tt>n_entries_per_row</tt> specifies the
      * number of entries in each row of the newly generated matrix.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     void
     reinit (const Epetra_Map             &row_parallel_partitioning,
@@ -549,6 +565,8 @@ namespace TrilinosWrappers
      * exchange_data can be used for reinitialization with a sparsity pattern
      * that is not fully constructed. This feature is only implemented for
      * input sparsity patterns of type DynamicSparsityPattern.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     template<typename SparsityType>
     void
@@ -564,6 +582,8 @@ namespace TrilinosWrappers
      * exchange_data can be used for reinitialization with a sparsity pattern
      * that is not fully constructed. This feature is only implemented for
      * input sparsity patterns of type DynamicSparsityPattern.
+     *
+     * @deprecated Use the respective method with IndexSet argument instead.
      */
     template<typename SparsityType>
     void
@@ -931,6 +951,8 @@ namespace TrilinosWrappers
      * sets the parallel partitioning of the domain space of this sparsity
      * pattern, i.e., the partitioning of the vectors matrices based on this
      * sparsity pattern are multiplied with.
+     *
+     * @deprecated Use locally_owned_domain_indices() instead.
      */
     const Epetra_Map &domain_partitioner () const DEAL_II_DEPRECATED;
 
@@ -939,6 +961,8 @@ namespace TrilinosWrappers
      * sets the partitioning of the range space of this sparsity pattern,
      * i.e., the partitioning of the vectors that are result from matrix-
      * vector products.
+     *
+     * @deprecated Use locally_owned_range_indices() instead.
      */
     const Epetra_Map &range_partitioner () const DEAL_II_DEPRECATED;
 
@@ -946,6 +970,8 @@ namespace TrilinosWrappers
      * Return a const reference to the underlying Trilinos Epetra_Map that
      * sets the partitioning of the sparsity pattern rows. Equal to the
      * partitioning of the range.
+     *
+     * @deprecated Use locally_owned_range_indices() instead.
      */
     const Epetra_Map &row_partitioner () const DEAL_II_DEPRECATED;
 
@@ -954,11 +980,16 @@ namespace TrilinosWrappers
      * sets the partitioning of the sparsity pattern columns. This is in
      * general not equal to the partitioner Epetra_Map for the domain because
      * of overlap in the matrix.
+     *
+     * @deprecated Usually not necessary. If desired, access via the
+     * Epetra_FECrsGraph.
      */
     const Epetra_Map &col_partitioner () const DEAL_II_DEPRECATED;
 
     /**
      * 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;
 
@@ -974,15 +1005,16 @@ namespace TrilinosWrappers
 //@{
 
     /**
-     * Return the partitioning of the domain space of this matrix, i.e., the
-     * partitioning of the vectors this matrix has to be multiplied with.
+     * Return the partitioning of the domain space of this pattern, i.e., the
+     * partitioning of the vectors a matrix based on this sparsity pattern has
+     * to be multiplied with.
      */
     IndexSet locally_owned_domain_indices() const;
 
     /**
-     * Return the partitioning of the range space of this matrix, i.e., the
-     * partitioning of the vectors that are result from matrix-vector
-     * products.
+     * Return the partitioning of the range space of this pattern, i.e., the
+     * partitioning of the vectors that are the result from matrix-vector
+     * products from a matrix based on this pattern.
      */
     IndexSet locally_owned_range_indices() 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.