]> https://gitweb.dealii.org/ - dealii.git/commitdiff
start removing use of CompressedSparsityPattern and friends
authorGuido Kanschat <dr.guido.kanschat@gmail.com>
Thu, 2 Apr 2015 10:03:37 +0000 (12:03 +0200)
committerGuido Kanschat <dr.guido.kanschat@gmail.com>
Thu, 2 Apr 2015 10:03:37 +0000 (12:03 +0200)
21 files changed:
include/deal.II/dofs/dof_tools.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/sparsity_tools.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/multigrid/sparse_matrix_collection.h
include/deal.II/numerics/vector_tools.templates.h
source/dofs/dof_renumbering.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_sparsity.cc
source/grid/grid_tools.cc
source/lac/chunk_sparsity_pattern.cc
source/lac/constraint_matrix.cc
source/lac/sparsity_tools.cc
source/lac/trilinos_sparsity_pattern.cc
source/multigrid/mg_tools.cc
source/multigrid/mg_transfer_prebuilt.cc
tests/arpack/step-36_ar.cc

index 686d50efb397b34fc0d996b770efdb601698a345..719e45110f690719d9eaaaeb276facbb0f9ff891 100644 (file)
@@ -362,9 +362,9 @@ namespace DoFTools
    * Remember using SparsityPattern::compress() after generating the pattern.
    *
    * The actual type of the sparsity pattern may be SparsityPattern,
-   * CompressedSparsityPattern, BlockSparsityPattern,
-   * BlockCompressedSparsityPattern, BlockCompressedSetSparsityPattern,
-   * BlockCompressedSimpleSparsityPattern, or any other class that satisfies
+   * DynamicSparsityPattern, BlockSparsityPattern,
+   * BlockDynamicSparsityPattern, BlockDynamicSetSparsityPattern,
+   * BlockDynamicSimpleSparsityPattern, or any other class that satisfies
    * similar requirements. It is assumed that the size of the sparsity pattern
    * matches the number of degrees of freedom and that enough unused nonzero
    * entries are left to fill the sparsity pattern. The nonzero entries
@@ -446,8 +446,8 @@ namespace DoFTools
    * resulting sparsity pattern.
    *
    * The actual type of the sparsity pattern may be SparsityPattern,
-   * CompressedSparsityPattern, BlockSparsityPattern,
-   * BlockCompressedSparsityPattern, BlockCompressedSetSparsityPattern, or any
+   * DynamicSparsityPattern, BlockSparsityPattern,
+   * BlockDynamicSparsityPattern, BlockDynamicSetSparsityPattern, or any
    * other class that satisfies similar requirements.
    *
    * There is a complication if some or all of the shape functions of the
@@ -529,8 +529,8 @@ namespace DoFTools
    * documentation of this class for more information.
    *
    * The actual type of the sparsity pattern may be SparsityPattern,
-   * CompressedSparsityPattern, BlockSparsityPattern,
-   * BlockCompressedSparsityPattern, BlockCompressedSetSparsityPattern, or any
+   * DynamicSparsityPattern, BlockSparsityPattern,
+   * BlockDynamicSparsityPattern, BlockDynamicSetSparsityPattern, or any
    * other class that satisfies similar requirements. It is assumed that the
    * size of the sparsity pattern is already correct.
    */
index 654f8a2893875a50d8f85cb318dae3ff8d57a511..7d506e52e378d31e9828ac1aeb21df5a9213027c 100644 (file)
@@ -481,8 +481,8 @@ public:
                   const size_type chunk_size);
 
   /**
-   * Copy data from an object of type CompressedSparsityPattern,
-   * CompressedSetSparsityPattern or CompressedSimpleSparsityPattern. Previous
+   * Copy data from an object of type DynamicSparsityPattern,
+   * DynamicSetSparsityPattern or DynamicSimpleSparsityPattern. Previous
    * content of this object is lost, and the sparsity pattern is in compressed
    * mode afterwards.
    */
index 4078822cfcc405ae72d228a519493c0786bf5ece..086493e33d7927e75fc38ae73bf9d6de676f17df 100644 (file)
@@ -70,13 +70,13 @@ template <typename number> class SparseMatrix;
  *
  * Use this class as follows:
  * @code
- * DynamicSparsityPattern compressed_pattern (dof_handler.n_dofs());
+ * DynamicSparsityPattern dynamic_pattern (dof_handler.n_dofs());
  * DoFTools::make_sparsity_pattern (dof_handler,
- *                                  compressed_pattern);
- * constraints.condense (compressed_pattern);
+ *                                  dynamic_pattern);
+ * constraints.condense (dynamic_pattern);
  *
  * SparsityPattern sp;
- * sp.copy_from (compressed_pattern);
+ * sp.copy_from (dynamic_pattern);
  * @endcode
  *
  * @author Timo Heister, 2008
index a912d13c4353da604eda466095b180492e6faa4a..e75b33427fd24ac10c297d5e74053603a695f2a2 100644 (file)
@@ -27,7 +27,7 @@
 #include <deal.II/lac/trilinos_sparse_matrix.h>
 #include <deal.II/lac/vector.h>
 #include <deal.II/lac/full_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/vector_memory.h>
 
 #include <ostream>
@@ -967,9 +967,9 @@ SparseMatrix<number>::mmult (SparseMatrix<numberC>       &C,
       // rows in the matrix A, and for each column in a row we add the whole
       // row of matrix B with that row number. This means that we will insert
       // a lot of entries to each row, which is best handled by the
-      // CompressedSimpleSparsityPattern class.
+      // DynamicSparsityPattern class.
       {
-        CompressedSimpleSparsityPattern csp (m(), B.n());
+        DynamicSparsityPattern csp (m(), B.n());
         for (size_type i = 0; i < csp.n_rows(); ++i)
           {
             const size_type *rows = &sp_A.colnums[sp_A.rowstart[i]];
@@ -1094,9 +1094,9 @@ SparseMatrix<number>::Tmmult (SparseMatrix<numberC>       &C,
       // rows in the matrix A, and for each column in a row we add the whole
       // row of matrix B with that row number. This means that we will insert
       // a lot of entries to each row, which is best handled by the
-      // CompressedSimpleSparsityPattern class.
+      // DynamicSparsityPattern class.
       {
-        CompressedSimpleSparsityPattern csp (n(), B.n());
+        DynamicSparsityPattern csp (n(), B.n());
         for (size_type i = 0; i < sp_A.n_rows(); ++i)
           {
             const size_type *rows =
index eac33c0f2dd8fba0dfb9fceb6277bf0c92516c37..1fa680ce9d8cbaeca174639c9261d376ec7bd078 100644 (file)
@@ -623,8 +623,7 @@ public:
                   const ForwardIterator end);
 
   /**
-   * Copy data from an object of type CompressedSparsityPattern,
-   * CompressedSetSparsityPattern or CompressedSimpleSparsityPattern. Although
+   * Copy data from an object of type DynamicSparsityPattern. Although
    * not a compressed sparsity pattern, this function is also instantiated if
    * the argument is of type SparsityPattern (i.e., the current class).
    * Previous content of this object is lost, and the sparsity pattern is in
index 3741f6328dbf279ad7e692e46bbcfb95d513334c..91f7f66ba614cb79735a84eb19f3428faea4adf1 100644 (file)
@@ -152,7 +152,7 @@ namespace SparsityTools
    *
    * @param myrange indicates the range of elements stored locally and should
    * be the one used in the constructor of the
-   * CompressedSimpleSparsityPattern.  This should be the locally relevant
+   * DynamicSparsityPattern.  This should be the locally relevant
    * set.  Only rows contained in myrange are checked in csp for transfer.
    * This function needs to be used with PETScWrappers::MPI::SparseMatrix for
    * it to work correctly in a parallel computation.
@@ -165,7 +165,7 @@ namespace SparsityTools
 
   /**
    * similar to the function above, but includes support for
-   * BlockCompressedSimpleSparsityPattern. @p owned_set_per_cpu is typically
+   * BlockDynamicSparsityPattern. @p owned_set_per_cpu is typically
    * DoFHandler::locally_owned_dofs_per_processor and @p myrange are
    * locally_relevant_dofs.
    */
index 87e0d4a9f923ff284586f81d3534282940b0cb8a..fe1d1cba64ae3f2b8aecd991b0afd51695582c46 100644 (file)
@@ -460,7 +460,7 @@ namespace TrilinosWrappers
    * <ul>
    * <li> The matrix uses only one MPI process.
    * <li> The matrix has been initialized with the reinit() method with a
-   * CompressedSimpleSparsityPattern (that includes the set of locally
+   * DynamicSparsityPattern (that includes the set of locally
    * relevant rows, i.e., the rows that an assembly routine will possibly
    * write into).
    * <li> The matrix has been initialized from a
@@ -722,11 +722,11 @@ namespace TrilinosWrappers
      * optional argument @p 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
-     * CompressedSimpleSparsityPattern. If the flag is not set, each processor
+     * DynamicSparsityPattern. If the flag is not set, each processor
      * just sets the elements in the sparsity pattern that belong to its rows.
      *
      * If the sparsity pattern given to this function is of type
-     * CompressedSimpleSparsity pattern, then a matrix will be created that
+     * DynamicSparsity pattern, then a matrix will be created that
      * allows several threads to write into different rows of the matrix at
      * the same also with MPI, as opposed to most other reinit() methods.
      *
@@ -745,7 +745,7 @@ namespace TrilinosWrappers
      * optional argument @p 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
-     * CompressedSimpleSparsityPattern.
+     * DynamicSparsityPattern.
      *
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
@@ -882,7 +882,7 @@ namespace TrilinosWrappers
      * to the deal.II own object. The optional argument @p 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 CompressedSimpleSparsityPattern. If the flag is not
+     * patterns of type DynamicSparsityPattern. If the flag is not
      * set, each processor just sets the elements in the sparsity pattern that
      * belong to its rows.
      *
@@ -902,7 +902,7 @@ namespace TrilinosWrappers
      * optional argument @p 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
-     * CompressedSimpleSparsityPattern.
+     * DynamicSparsityPattern.
      *
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
index 86a9fe81a3b780e92983cd56d969eed2d55ffe1a..a23bcbc9939a9c13509fc4edb10af4dd4b24cadd 100644 (file)
@@ -255,9 +255,7 @@ namespace TrilinosWrappers
    * with the difference that this class can work fully in %parallel according
    * to a partitioning of the sparsity pattern rows.
    *
-   * This class has many similarities to the compressed sparsity pattern
-   * classes of deal.II (i.e., the classes CompressedSparsityPattern,
-   * CompressedSetSparsityPattern, and CompressedSimpleSparsityPattern), since
+   * This class has many similarities to the  DynamicSparsityPattern, since
    * it can dynamically add elements to the pattern without any memory being
    * previously reserved for it. However, it also has a method
    * SparsityPattern::compress(), that finalizes the pattern and enables its
@@ -301,7 +299,7 @@ namespace TrilinosWrappers
      * not have this kind of information before building the sparsity pattern
      * (the usual case when the function DoFTools::make_sparsity_pattern() is
      * called). The entries are allocated dynamically in a similar manner as
-     * for the deal.II CompressedSparsityPattern classes. However, a good
+     * for the deal.II DynamicSparsityPattern classes. However, a good
      * estimate will reduce the setup time of the sparsity pattern.
      */
     SparsityPattern (const size_type  m,
@@ -339,7 +337,7 @@ namespace TrilinosWrappers
      * The number of columns entries per row is specified as the maximum
      * number of entries argument.  This does not need to be an accurate
      * number since the entries are allocated dynamically in a similar manner
-     * as for the deal.II CompressedSparsityPattern classes, but a good
+     * as for the deal.II DynamicSparsityPattern classes, but a good
      * estimate will reduce the setup time of the sparsity pattern.
      */
     void
@@ -547,7 +545,7 @@ namespace TrilinosWrappers
      * current Trilinos sparsity pattern. The optional argument @p
      * 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 CompressedSimpleSparsityPattern.
+     * input sparsity patterns of type DynamicSparsityPattern.
      */
     template<typename SparsityType>
     void
@@ -562,7 +560,7 @@ namespace TrilinosWrappers
      * current Trilinos sparsity pattern. The optional argument @p
      * 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 CompressedSimpleSparsityPattern.
+     * input sparsity patterns of type DynamicSparsityPattern.
      */
     template<typename SparsityType>
     void
@@ -777,7 +775,7 @@ namespace TrilinosWrappers
      * sparsity pattern. The optional argument @p 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 CompressedSimpleSparsityPattern.
+     * patterns of type DynamicSparsityPattern.
      */
     template<typename SparsityType>
     void
@@ -793,7 +791,7 @@ namespace TrilinosWrappers
      * current Trilinos sparsity pattern. The optional argument @p
      * 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 CompressedSimpleSparsityPattern.
+     * input sparsity patterns of type DynamicSparsityPattern.
      */
     template<typename SparsityType>
     void
index 2db9c42d3f88e331b34dd909667a11053d2d421c..39dd085a9cffaaa661719489d59291067b174592 100644 (file)
@@ -19,7 +19,7 @@
 #include <deal.II/lac/vector.h>
 #include <deal.II/lac/pointer_matrix.h>
 #include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/multigrid/mg_base.h>
 #include <deal.II/multigrid/mg_tools.h>
 #include <deal.II/base/mg_level_object.h>
@@ -87,7 +87,7 @@ namespace mg
     for (unsigned int level=sparsity.min_level();
          level<=sparsity.max_level(); ++level)
       {
-        CompressedSparsityPattern c_sparsity(dof_handler.n_dofs(level));
+        DynamicSparsityPattern c_sparsity(dof_handler.n_dofs(level));
         MGTools::make_flux_sparsity_pattern(dof_handler, c_sparsity, level);
         sparsity[level].copy_from(c_sparsity);
         matrix[level].reinit(sparsity[level]);
@@ -95,7 +95,7 @@ namespace mg
         matrix_out[level].reinit(sparsity[level]);
         if (level>0)
           {
-            CompressedSparsityPattern ci_sparsity;
+            DynamicSparsityPattern ci_sparsity;
             ci_sparsity.reinit(dof_handler.n_dofs(level-1), dof_handler.n_dofs(level));
             MGTools::make_flux_sparsity_pattern_edge(dof_handler, ci_sparsity, level);
             sparsity_edge[level].copy_from(ci_sparsity);
index 8f0492ec333aec933d83316b6c2ab11c3f3149a0..652f62a72609025d63a80dd93097886dc23393a9 100644 (file)
@@ -29,8 +29,7 @@
 #include <deal.II/lac/trilinos_vector.h>
 #include <deal.II/lac/trilinos_block_vector.h>
 #include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/precondition.h>
 #include <deal.II/lac/solver_cg.h>
 #include <deal.II/lac/vector_memory.h>
@@ -753,7 +752,7 @@ namespace VectorTools
       dealii::Vector<double> vec (dof.n_dofs());
       SparsityPattern sparsity;
       {
-        CompressedSimpleSparsityPattern csp (dof.n_dofs(), dof.n_dofs());
+        DynamicSparsityPattern csp (dof.n_dofs(), dof.n_dofs());
         DoFTools::make_sparsity_pattern (dof, csp, constraints,
                                          !constraints_are_compatible);
 
@@ -2177,7 +2176,7 @@ namespace VectorTools
         return;
 
       // set up sparsity structure
-      CompressedSparsityPattern c_sparsity(dof.n_boundary_dofs (boundary_functions),
+      DynamicSparsityPattern c_sparsity(dof.n_boundary_dofs (boundary_functions),
                                            dof.n_boundary_dofs (boundary_functions));
       DoFTools::make_boundary_sparsity_pattern (dof,
                                                 boundary_functions,
index 9a3e5e6bcdadc407ec6a3966e64876c71750ab6a..d22b3c2090da59b5c47926bed9f4bd19accc2e44 100644 (file)
@@ -21,7 +21,7 @@
 
 #include <deal.II/lac/sparsity_pattern.h>
 #include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/constraint_matrix.h>
 
 #include <deal.II/dofs/dof_accessor.h>
@@ -101,7 +101,7 @@ namespace DoFRenumbering
           if (use_constraints)
             DoFTools::make_hanging_node_constraints (dof_handler, constraints);
           constraints.close ();
-          CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
+          DynamicSparsityPattern csp (dof_handler.n_dofs(),
                                                dof_handler.n_dofs());
           DoFTools::make_sparsity_pattern (dof_handler, csp, constraints);
 
@@ -411,7 +411,7 @@ namespace DoFRenumbering
       }
     else
       {
-        CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
+        DynamicSparsityPattern csp (dof_handler.n_dofs(),
                                              dof_handler.n_dofs(),
                                              dof_handler.locally_owned_dofs());
         DoFTools::make_sparsity_pattern (dof_handler, csp, constraints);
@@ -433,7 +433,7 @@ namespace DoFRenumbering
               {
                 const types::global_dof_index row = locally_owned.nth_index_in_set(i);
                 row_entries.resize(0);
-                for (CompressedSimpleSparsityPattern::row_iterator it =
+                for (DynamicSparsityPattern::row_iterator it =
                        csp.row_begin(row); it != csp.row_end(row); ++it)
                   if (*it != row && locally_owned.is_element(*it))
                     row_entries.push_back(locally_owned.index_within_set(*it));
@@ -487,7 +487,7 @@ namespace DoFRenumbering
       }
     else
       {
-        CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(level),
+        DynamicSparsityPattern csp (dof_handler.n_dofs(level),
                                              dof_handler.n_dofs(level));
         MGTools::make_sparsity_pattern (dof_handler, csp, level);
         sparsity.copy_from (csp);
index 76a7a9ee4fcf7dc48c85b0cac7eaa466eb7b247b..8848982ab1ea9f064a05401ea82f8fcb44133b34 100644 (file)
@@ -19,9 +19,7 @@
 #include <deal.II/base/template_constraints.h>
 #include <deal.II/base/utilities.h>
 #include <deal.II/lac/sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/trilinos_sparsity_pattern.h>
 #include <deal.II/lac/block_sparsity_pattern.h>
 #include <deal.II/lac/vector.h>
index a907ee60bcab4717925be454dc0fdf483df0d8df..b377639e91a2dbea38d734e82d911abb62c5c629 100644 (file)
@@ -19,9 +19,7 @@
 #include <deal.II/base/template_constraints.h>
 #include <deal.II/base/utilities.h>
 #include <deal.II/lac/sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/trilinos_sparsity_pattern.h>
 #include <deal.II/lac/block_sparsity_pattern.h>
 #include <deal.II/lac/vector.h>
index 5401887b7a7ed63415fb07e6570066c6e4159385..59329c5b995e7733155e9f9729b76025b020a147 100644 (file)
 #include <deal.II/lac/precondition.h>
 #include <deal.II/lac/solver_cg.h>
 #include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/constraint_matrix.h>
 #include <deal.II/lac/sparsity_pattern.h>
 #include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
 #include <deal.II/grid/tria.h>
 #include <deal.II/distributed/tria.h>
 #include <deal.II/grid/tria_accessor.h>
@@ -693,7 +692,7 @@ namespace GridTools
     DoFHandler<dim> dof_handler(triangulation);
     dof_handler.distribute_dofs(q1);
 
-    CompressedSparsityPattern c_sparsity_pattern (dof_handler.n_dofs (),
+    DynamicSparsityPattern c_sparsity_pattern (dof_handler.n_dofs (),
                                                   dof_handler.n_dofs ());
     DoFTools::make_sparsity_pattern (dof_handler, c_sparsity_pattern);
     c_sparsity_pattern.compress ();
index 4c22a45ba0f3f06b3c33dd5deb58c4e45398c984..3a03a470eed5dae889602a78f99fd1881c19f1af 100644 (file)
@@ -15,9 +15,7 @@
 
 
 #include <deal.II/lac/chunk_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/full_matrix.h>
 
 
@@ -626,7 +624,7 @@ template
 void ChunkSparsityPattern::create_from<DynamicSparsityPattern>
 (const unsigned int,
  const unsigned int,
- const CompressedSparsityPattern &,
+ const DynamicSparsityPattern &,
  const unsigned int,
  const bool);
 template
index 3da83d75d1846b45171505681618272744a49874..479d9f18947c94a3e914944d928ec0328ac64c2c 100644 (file)
@@ -965,7 +965,7 @@ void ConstraintMatrix::condense (BlockDynamicSparsityPattern &sparsity) const
         // the loop over cols may get longer.
         //
         // don't try to be clever here as in the algorithm for the
-        // CompressedSparsityPattern, as that would be much more
+        // DynamicSparsityPattern, as that would be much more
         // complicated here. after all, we know that compressed patterns
         // are inefficient...
         {
index 492ee1589c8825782b8a3fdb9a471eee4754a0c7..87ac00e897a9cd3098c8f567c1bccd2d9a97f068 100644 (file)
@@ -643,8 +643,8 @@ namespace SparsityTools
 SPARSITY_FUNCTIONS(DynamicSparsityPattern);
 
 template void SparsityTools::distribute_sparsity_pattern
-<BlockCompressedSimpleSparsityPattern>
-(BlockCompressedSimpleSparsityPattern &csp,
+<BlockDynamicSparsityPattern>
+(BlockDynamicSparsityPattern &csp,
  const std::vector<IndexSet> &owned_set_per_cpu,
  const MPI_Comm &mpi_comm,
  const IndexSet &myrange);
index f348004b2eccb954844a384c3ce31b3a050ef0d5..5ab4ea8dd14b8b0bb0eda6506871323e5aae109f 100644 (file)
@@ -628,7 +628,7 @@ namespace TrilinosWrappers
     std::vector<TrilinosWrappers::types::int_type> row_indices;
 
     // Include possibility to exchange data
-    // since CompressedSimpleSparsityPattern is
+    // since DynamicSparsityPattern is
     // able to do so
     if (exchange_data==false)
       for (size_type row=first_row; row<last_row; ++row)
index 70025fbb6152b5bcb39d62745624ca37f4836010..781456810a4dd95f1bf044b6b01db3b1de4d232c 100644 (file)
@@ -17,7 +17,7 @@
 #include <deal.II/base/thread_management.h>
 #include <deal.II/lac/sparsity_pattern.h>
 #include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/sparsity_pattern.h>
 #include <deal.II/lac/block_vector.h>
 #include <deal.II/lac/sparse_matrix.h>
index 1c206120eb12da60ba480b0651b6a473208b105e..f24266e56cdcead52c8ae61616407e05554b8f17 100644 (file)
@@ -27,7 +27,7 @@
 #include <deal.II/lac/trilinos_block_vector.h>
 #include <deal.II/lac/sparse_matrix.h>
 #include <deal.II/lac/block_sparse_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/dofs/dof_tools.h>
@@ -168,7 +168,7 @@ void MGTransferPrebuilt<VECTOR>::build_matrices (
       // increment dofs_per_cell
       // since a useless diagonal
       // element will be stored
-      CompressedSimpleSparsityPattern csp (sizes[level+1],
+      DynamicSparsityPattern csp (sizes[level+1],
                                            sizes[level]);
       std::vector<types::global_dof_index> entries (dofs_per_cell);
       for (typename DoFHandler<dim,spacedim>::cell_iterator cell=mg_dof.begin(level);
index 400c7c344e2f6a6eddf7b850836e94ffa7d6d4fc..13592789dc3f496e23938d4afab916d811c47a2f 100644 (file)
@@ -45,7 +45,7 @@
 #include <deal.II/lac/arpack_solver.h>
 #include <deal.II/lac/sparse_direct.h>
 #include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
 
 #include <complex>
 

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.