]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated functions in ChunkSparsityPattern.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 22 Jan 2015 13:20:56 +0000 (07:20 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 22 Jan 2015 13:20:56 +0000 (07:20 -0600)
doc/news/changes.h
include/deal.II/lac/chunk_sparsity_pattern.h
source/lac/chunk_sparsity_pattern.cc
tests/bits/chunk_sparse_matrix_00.cc

index 3a30356d57bab1bacd12c95c6dc624d8ca094afa..d8e1bff1ec2ab21f50345fbae5f8d1ede79facb7 100644 (file)
@@ -150,6 +150,8 @@ inconvenience this causes.
   - Vector::scale.
   - TrilinosWrappers::*Vector*::compress with an Epetra_CombineMode
     argument
+  - ChunkSparsityPattern functions that take an
+    <code>optimize_diagonal</code> argument.
   <br>
   This release also removes the deprecated class MGDoFHandler. The
   functionality of this class had previously been incorporated into
index 94852481ab221b702f253f0c5e7b941962037b8f..654f8a2893875a50d8f85cb318dae3ff8d57a511 100644 (file)
@@ -296,16 +296,6 @@ public:
                         const size_type max_chunks_per_row,
                         const size_type chunk_size);
 
-  /**
-   * @deprecated This constructor is deprecated. Use the version without the
-   * last argument
-   */
-  ChunkSparsityPattern (const size_type m,
-                        const size_type n,
-                        const size_type max_chunks_per_row,
-                        const size_type chunk_size,
-                        const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * Initialize a rectangular matrix.
    *
@@ -318,16 +308,6 @@ public:
                         const std::vector<size_type> &row_lengths,
                         const size_type chunk_size);
 
-  /**
-   * @deprecated This constructor is deprecated. Use the version without the
-   * last argument
-   */
-  ChunkSparsityPattern (const size_type               m,
-                        const size_type               n,
-                        const std::vector<size_type> &row_lengths,
-                        const size_type chunk_size,
-                        const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * Initialize a quadratic matrix of dimension <tt>n</tt> with at most
    * <tt>max_per_row</tt> nonzero entries per row.
@@ -351,15 +331,6 @@ public:
                         const std::vector<size_type>  &row_lengths,
                         const size_type                chunk_size);
 
-  /**
-   * @deprecated This constructor is deprecated. Use the version without the
-   * last argument
-   */
-  ChunkSparsityPattern (const size_type               m,
-                        const std::vector<size_type> &row_lengths,
-                        const size_type               chunk_size,
-                        const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * Destructor.
    */
@@ -385,16 +356,6 @@ public:
                const size_type max_per_row,
                const size_type chunk_size);
 
-  /**
-   * @deprecated This function is deprecated. Use the function without the
-   * last argument
-   */
-  void reinit (const size_type m,
-               const size_type n,
-               const size_type max_per_row,
-               const size_type chunk_size,
-               const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * Reallocate memory for a matrix of size <tt>m x n</tt>. The number of
    * entries for each row is taken from the array <tt>row_lengths</tt> which
@@ -414,16 +375,6 @@ public:
                const std::vector<size_type> &row_lengths,
                const size_type chunk_size);
 
-  /**
-   * @deprecated This function is deprecated. Use the function without the
-   * last argument
-   */
-  void reinit (const size_type                m,
-               const size_type                n,
-               const std::vector<size_type > &row_lengths,
-               const size_type                chunk_size,
-               const bool                     optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * Same as above, but with a VectorSlice argument instead.
    */
@@ -432,16 +383,6 @@ public:
                const VectorSlice<const std::vector<size_type> > &row_lengths,
                const size_type chunk_size);
 
-  /**
-   * @deprecated This function is deprecated. Use the function without the
-   * last argument
-   */
-  void reinit (const size_type m,
-               const size_type n,
-               const VectorSlice<const std::vector<size_type> > &row_lengths,
-               const size_type chunk_size,
-               const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * This function compresses the sparsity structure that this object
    * represents.  It does so by eliminating unused entries and sorting the
@@ -539,18 +480,6 @@ public:
                   const ForwardIterator end,
                   const size_type chunk_size);
 
-  /**
-   * @deprecated This function is deprecated. Use the function without the
-   * last argument
-   */
-  template <typename ForwardIterator>
-  void copy_from (const size_type       n_rows,
-                  const size_type       n_cols,
-                  const ForwardIterator begin,
-                  const ForwardIterator end,
-                  const size_type       chunk_size,
-                  const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * Copy data from an object of type CompressedSparsityPattern,
    * CompressedSetSparsityPattern or CompressedSimpleSparsityPattern. Previous
@@ -561,15 +490,6 @@ public:
   void copy_from (const SparsityType &csp,
                   const size_type     chunk_size);
 
-  /**
-   * @deprecated This function is deprecated. Use the function without the
-   * last argument
-   */
-  template <typename SparsityType>
-  void copy_from (const SparsityType &csp,
-                  const size_type     chunk_size,
-                  const bool          optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * Take a full matrix and use its nonzero entries to generate a sparse
    * matrix entry pattern for this object.
@@ -581,15 +501,6 @@ public:
   void copy_from (const FullMatrix<number> &matrix,
                   const size_type chunk_size);
 
-  /**
-   * @deprecated This function is deprecated. Use the function without the
-   * last argument
-   */
-  template <typename number>
-  void copy_from (const FullMatrix<number> &matrix,
-                  const size_type chunk_size,
-                  const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
   /**
    * Set the sparsity pattern of the chunk sparsity pattern to be given by
    * <tt>chunk_size*chunksize</tt> blocks of the sparsity pattern for chunks
@@ -696,15 +607,6 @@ public:
    */
   bool is_compressed () const;
 
-  /**
-   * Determine whether the matrix uses the special convention for quadratic
-   * matrices that the diagonal entries are stored first in each row.
-   *
-   * @deprecated The function always returns true if the matrix is square and
-   * false if it is not.
-   */
-  bool optimize_diagonal () const DEAL_II_DEPRECATED;
-
   /**
    * Return whether this object stores only those entries that have been added
    * explicitly, or if the sparsity pattern contains elements that have been
@@ -1252,30 +1154,6 @@ ChunkSparsityPattern::is_compressed () const
 
 
 
-inline
-bool
-ChunkSparsityPattern::optimize_diagonal () const
-{
-  return sparsity_pattern.store_diagonal_first_in_row;
-}
-
-
-
-template <typename ForwardIterator>
-inline
-void
-ChunkSparsityPattern::copy_from (const size_type n_rows,
-                                 const size_type n_cols,
-                                 const ForwardIterator begin,
-                                 const ForwardIterator end,
-                                 const size_type chunk_size,
-                                 const bool)
-{
-  copy_from (n_rows, n_cols, begin, end, chunk_size);
-}
-
-
-
 template <typename ForwardIterator>
 void
 ChunkSparsityPattern::copy_from (const size_type       n_rows,
index 1dc22517a74e3ab102f85674c10838c9151d623c..b4b63b5af5c2be24a584a55012d927d6ea7a33f7 100644 (file)
@@ -45,18 +45,6 @@ ChunkSparsityPattern::ChunkSparsityPattern (const ChunkSparsityPattern &s)
 
 
 
-ChunkSparsityPattern::ChunkSparsityPattern (const size_type m,
-                                            const size_type n,
-                                            const size_type max_per_row,
-                                            const size_type chunk_size,
-                                            const bool)
-{
-  Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
-
-  reinit (m,n,max_per_row, chunk_size);
-}
-
-
 ChunkSparsityPattern::ChunkSparsityPattern (const size_type m,
                                             const size_type n,
                                             const size_type max_per_row,
@@ -69,20 +57,6 @@ ChunkSparsityPattern::ChunkSparsityPattern (const size_type m,
 
 
 
-ChunkSparsityPattern::ChunkSparsityPattern (
-  const size_type m,
-  const size_type n,
-  const std::vector<size_type> &row_lengths,
-  const size_type chunk_size,
-  const bool)
-{
-  Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
-
-  reinit (m, n, row_lengths, chunk_size);
-}
-
-
-
 ChunkSparsityPattern::ChunkSparsityPattern (
   const size_type m,
   const size_type n,
@@ -105,19 +79,6 @@ ChunkSparsityPattern::ChunkSparsityPattern (const size_type n,
 
 
 
-ChunkSparsityPattern::ChunkSparsityPattern (
-  const size_type m,
-  const std::vector<size_type> &row_lengths,
-  const size_type chunk_size,
-  const bool)
-{
-  Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
-
-  reinit (m, m, row_lengths, chunk_size);
-}
-
-
-
 ChunkSparsityPattern::ChunkSparsityPattern (
   const size_type                m,
   const std::vector<size_type > &row_lengths,
@@ -149,17 +110,6 @@ ChunkSparsityPattern::operator = (const ChunkSparsityPattern &s)
 
 
 
-void
-ChunkSparsityPattern::reinit (const size_type m,
-                              const size_type n,
-                              const size_type max_per_row,
-                              const size_type chunk_size,
-                              const bool)
-{
-  reinit (m, n, max_per_row, chunk_size);
-}
-
-
 void
 ChunkSparsityPattern::reinit (const size_type m,
                               const size_type n,
@@ -175,18 +125,6 @@ ChunkSparsityPattern::reinit (const size_type m,
 
 
 
-void
-ChunkSparsityPattern::reinit (
-  const size_type m,
-  const size_type n,
-  const VectorSlice<const std::vector<size_type> > &row_lengths,
-  const size_type chunk_size,
-  const bool)
-{
-  reinit (m, n, row_lengths, chunk_size);
-}
-
-
 void
 ChunkSparsityPattern::reinit (
   const size_type m,
@@ -241,17 +179,6 @@ ChunkSparsityPattern::compress ()
 
 
 
-template <typename SparsityType>
-void
-ChunkSparsityPattern::copy_from (const SparsityType &csp,
-                                 const size_type     chunk_size,
-                                 const bool)
-{
-  copy_from (csp, chunk_size);
-}
-
-
-
 namespace internal
 {
   namespace
@@ -322,15 +249,6 @@ ChunkSparsityPattern::copy_from (const SparsityType &csp,
 
 
 
-template <typename number>
-void ChunkSparsityPattern::copy_from (const FullMatrix<number> &matrix,
-                                      const size_type chunk_size,
-                                      const bool)
-{
-  copy_from (matrix, chunk_size);
-}
-
-
 template <typename number>
 void ChunkSparsityPattern::copy_from (const FullMatrix<number> &matrix,
                                       const size_type chunk_size)
@@ -369,17 +287,6 @@ void ChunkSparsityPattern::copy_from (const FullMatrix<number> &matrix,
 }
 
 
-void
-ChunkSparsityPattern::reinit (
-  const size_type m,
-  const size_type n,
-  const std::vector<size_type> &row_lengths,
-  const size_type chunk_size,
-  const bool)
-{
-  reinit (m, n, row_lengths, chunk_size);
-}
-
 
 void
 ChunkSparsityPattern::reinit (
@@ -738,22 +645,6 @@ ChunkSparsityPattern::memory_consumption () const
 
 // explicit instantiations
 template
-void ChunkSparsityPattern::copy_from<SparsityPattern> (const SparsityPattern &,
-                                                       const size_type,
-                                                       const bool);
-template
-void ChunkSparsityPattern::copy_from<CompressedSparsityPattern> (const CompressedSparsityPattern &,
-    const size_type ,
-    const bool);
-template
-void ChunkSparsityPattern::copy_from<CompressedSetSparsityPattern> (const CompressedSetSparsityPattern &,
-    const size_type ,
-    const bool);
-template
-void ChunkSparsityPattern::copy_from<CompressedSimpleSparsityPattern> (const CompressedSimpleSparsityPattern &,
-    const size_type ,
-    const bool);
-template
 void ChunkSparsityPattern::copy_from<CompressedSparsityPattern> (const CompressedSparsityPattern &,
     const size_type);
 template
@@ -791,14 +682,6 @@ void ChunkSparsityPattern::create_from<CompressedSimpleSparsityPattern>
  const unsigned int,
  const bool);
 template
-void ChunkSparsityPattern::copy_from<float> (const FullMatrix<float> &,
-                                             const size_type ,
-                                             const bool);
-template
-void ChunkSparsityPattern::copy_from<double> (const FullMatrix<double> &,
-                                              const size_type ,
-                                              const bool);
-template
 void ChunkSparsityPattern::copy_from<float> (const FullMatrix<float> &,
                                              const size_type);
 template
index acb07edb6ba2437ee890c3d4dc0705c2366bdfe2..e2ad8b7ef4be2f4a12b18618eb01f8844eff49b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -28,7 +28,7 @@ void test (const unsigned int chunk_size)
 {
   deallog << "Chunk size = " << chunk_size << std::endl;
 
-  ChunkSparsityPattern sp (5,5,3,chunk_size,false);
+  ChunkSparsityPattern sp (5,5,3,chunk_size);
   for (unsigned int i=0; i<5; ++i)
     for (unsigned int j=0; j<5; ++j)
       if ((i+2*j+1) % 3 == 0)

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.