]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fix warnings (deprecated functions, unused variables.
authorkronbichler <kronbichler@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 12 Feb 2013 09:44:10 +0000 (09:44 +0000)
committerkronbichler <kronbichler@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 12 Feb 2013 09:44:10 +0000 (09:44 +0000)
git-svn-id: https://svn.dealii.org/trunk@28318 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/fe/fe.h
deal.II/include/deal.II/lac/sparse_decomposition.templates.h
deal.II/source/lac/chunk_sparsity_pattern.cc
deal.II/source/lac/trilinos_sparse_matrix.cc
deal.II/source/lac/trilinos_sparsity_pattern.cc
deal.II/source/multigrid/mg_tools.cc

index 8b260a3b5ec732134cbeb56f90d60d4abfd36c71..999fd6466cd32e299839dc1328c36a6f2facde81 100644 (file)
@@ -2079,7 +2079,7 @@ public:
   DeclException2 (ExcComponentIndexInvalid,
                   int, int,
                   << "The component-index pair (" << arg1 << ", " << arg2
-                  << ") is invalid, i.e. non-existent");
+                  << ") is invalid, i.e. non-existent.");
   /**
    * Exception
    * @ingroup Exceptions
index 33a47c6e2226238ad36593b3216617e1c00f6c56..3935ef107b2efeab4abf3e7db903ff68571805da 100644 (file)
@@ -214,7 +214,6 @@ SparseLUDecomposition<number>::copy_from (const SparseMatrix<somenumber> &matrix
   SparseMatrix<number>::operator= (number(0));
 
   // both allow more and less entries in the new matrix
-  std::size_t in_index, index;
   for (unsigned int row=0; row<this->m(); ++row)
     {
       typename SparseMatrix<number>::iterator index = this->begin(row);
index d2a1ed74d5e8268745ea610e97b067d105ed940f..4fdc3389c0882c9b7ff92a80aff2a715ce88fcba 100644 (file)
@@ -251,6 +251,35 @@ ChunkSparsityPattern::copy_from (const SparsityType &csp,
 }
 
 
+
+namespace internal
+{
+  namespace
+  {
+    // distinguish between compressed sparsity types that define row_begin()
+    // and SparsityPattern that uses begin() as iterator type
+    template <typename Sparsity>
+    void copy_row (const Sparsity       &csp,
+                   const unsigned int    row,
+                   ChunkSparsityPattern &dst)
+    {
+      typename Sparsity::row_iterator col_num = csp.row_begin (row);
+      for (; col_num != csp.row_end (row); ++col_num)
+        dst.add (row, *col_num);
+    }
+
+    void copy_row (const SparsityPattern &csp,
+                   const unsigned int     row,
+                   ChunkSparsityPattern  &dst)
+    {
+      SparsityPattern::iterator col_num = csp.begin (row);
+      for (; col_num != csp.end (row); ++col_num)
+        dst.add (row, col_num->column());
+    }
+  }
+}
+
+
 template <typename SparsityType>
 void
 ChunkSparsityPattern::copy_from (const SparsityType &csp,
@@ -271,12 +300,7 @@ ChunkSparsityPattern::copy_from (const SparsityType &csp,
 
   // then actually fill it
   for (unsigned int row = 0; row<csp.n_rows(); ++row)
-    {
-      typename SparsityType::row_iterator col_num = csp.row_begin (row);
-
-      for (; col_num != csp.row_end (row); ++col_num)
-        add (row, *col_num);
-    }
+    internal::copy_row(csp, row, *this);
 
   // finally compress
   compress ();
index 5442c86c27ab9e683c675e01a53cc8d1ea6b04d4..0163269d84ad7ee320f57a058b83525de8674579 100644 (file)
@@ -361,6 +361,35 @@ namespace TrilinosWrappers
 
 
 
+  namespace internal
+  {
+    namespace
+    {
+    // distinguish between compressed sparsity types that define row_begin()
+    // and SparsityPattern that uses begin() as iterator type
+      template <typename Sparsity>
+      void copy_row (const Sparsity     &csp,
+                     const unsigned int  row,
+                     std::vector<int>   &row_indices)
+      {
+        typename Sparsity::row_iterator col_num = csp.row_begin (row);
+        for (unsigned int col=0; col_num != csp.row_end (row); ++col_num, ++col)
+          row_indices[col] = *col_num;
+      }
+
+      void copy_row (const dealii::SparsityPattern &csp,
+                     const unsigned int             row,
+                     std::vector<int>              &row_indices)
+      {
+        dealii::SparsityPattern::iterator col_num = csp.begin (row);
+        for (unsigned int col=0; col_num != csp.end (row); ++col_num, ++col)
+          row_indices[col] = col_num->column();
+      }
+    }
+  }
+
+
+
   template <typename SparsityType>
   void
   SparseMatrix::reinit (const Epetra_Map    &input_row_map,
@@ -372,14 +401,10 @@ namespace TrilinosWrappers
     temp_vector.clear();
     matrix.reset();
 
-    // if we want to exchange data, build
-    // a usual Trilinos sparsity pattern
-    // and let that handle the
-    // exchange. otherwise, manually
-    // create a CrsGraph, which consumes
-    // considerably less memory because it
-    // can set correct number of indices
-    // right from the start
+    // if we want to exchange data, build a usual Trilinos sparsity pattern
+    // and let that handle the exchange. otherwise, manually create a
+    // CrsGraph, which consumes considerably less memory because it can set
+    // correct number of indices right from the start
     if (exchange_data)
       {
         SparsityPattern trilinos_sparsity;
@@ -408,29 +433,19 @@ namespace TrilinosWrappers
     for (unsigned int row=first_row; row<last_row; ++row)
       n_entries_per_row[row-first_row] = sparsity_pattern.row_length(row);
 
-    // The deal.II notation of a Sparsity
-    // pattern corresponds to the Epetra
-    // concept of a Graph. Hence, we generate
-    // a graph by copying the sparsity pattern
-    // into it, and then build up the matrix
-    // from the graph. This is considerable
-    // faster than directly filling elements
-    // into the matrix. Moreover, it consumes
-    // less memory, since the internal
-    // reordering is done on ints only, and we
-    // can leave the doubles aside.
-
-    // for more than one processor, need to
-    // specify only row map first and let the
-    // matrix entries decide about the column
-    // map (which says which columns are
-    // present in the matrix, not to be
-    // confused with the col_map that tells
-    // how the domain dofs of the matrix will
-    // be distributed). for only one
-    // processor, we can directly assign the
-    // columns as well. Compare this with bug
-    // # 4123 in the Sandia Bugzilla.
+    // The deal.II notation of a Sparsity pattern corresponds to the Epetra
+    // concept of a Graph. Hence, we generate a graph by copying the sparsity
+    // pattern into it, and then build up the matrix from the graph. This is
+    // considerable faster than directly filling elements into the
+    // matrix. Moreover, it consumes less memory, since the internal
+    // reordering is done on ints only, and we can leave the doubles aside.
+
+    // for more than one processor, need to specify only row map first and let
+    // the matrix entries decide about the column map (which says which
+    // columns are present in the matrix, not to be confused with the col_map
+    // that tells how the domain dofs of the matrix will be distributed). for
+    // only one processor, we can directly assign the columns as well. Compare
+    // this with bug # 4123 in the Sandia Bugzilla.
     std_cxx1x::shared_ptr<Epetra_CrsGraph> graph;
     if (input_row_map.Comm().NumProc() > 1)
       graph.reset (new Epetra_CrsGraph (Copy, input_row_map,
@@ -439,10 +454,8 @@ namespace TrilinosWrappers
       graph.reset (new Epetra_CrsGraph (Copy, input_row_map, input_col_map,
                                         &n_entries_per_row[0], true));
 
-    // This functions assumes that the
-    // sparsity pattern sits on all processors
-    // (completely). The parallel version uses
-    // an Epetra graph that is already
+    // This functions assumes that the sparsity pattern sits on all processors
+    // (completely). The parallel version uses an Epetra graph that is already
     // distributed.
 
     // now insert the indices
@@ -455,24 +468,17 @@ namespace TrilinosWrappers
           continue;
 
         row_indices.resize (row_length, -1);
-
-        typename SparsityType::row_iterator col_num = sparsity_pattern.row_begin (row),
-                                            row_end = sparsity_pattern.row_end(row);
-        for (unsigned int col = 0; col_num != row_end; ++col_num, ++col)
-          row_indices[col] = *col_num;
-
+        internal::copy_row(sparsity_pattern, row, row_indices);
         graph->Epetra_CrsGraph::InsertGlobalIndices (row, row_length,
                                                      &row_indices[0]);
       }
 
-    // Eventually, optimize the graph
-    // structure (sort indices, make memory
+    // Eventually, optimize the graph structure (sort indices, make memory
     // contiguous, etc).
     graph->FillComplete(input_col_map, input_row_map);
     graph->OptimizeStorage();
 
-    // check whether we got the number of
-    // columns right.
+    // check whether we got the number of columns right.
     AssertDimension (sparsity_pattern.n_cols(),
                      static_cast<unsigned int>(graph->NumGlobalCols()));
 
@@ -480,9 +486,8 @@ namespace TrilinosWrappers
     matrix.reset (new Epetra_FECrsMatrix(Copy, *graph, false));
     last_action = Zero;
 
-    // In the end, the matrix needs to
-    // be compressed in order to be
-    // really ready.
+    // In the end, the matrix needs to be compressed in order to be really
+    // ready.
     compress();
   }
 
index b3d2dabf0cf614bf6b204e25a0cce9634b86ec0d..9d2e1f88688c731fc39f0e3ff4a4b4d256ea05b2 100644 (file)
@@ -271,6 +271,35 @@ namespace TrilinosWrappers
 
 
 
+  namespace internal
+  {
+    namespace
+    {
+    // distinguish between compressed sparsity types that define row_begin()
+    // and SparsityPattern that uses begin() as iterator type
+      template <typename Sparsity>
+      void copy_row (const Sparsity     &csp,
+                     const unsigned int  row,
+                     std::vector<int>   &row_indices)
+      {
+        typename Sparsity::row_iterator col_num = csp.row_begin (row);
+        for (unsigned int col=0; col_num != csp.row_end (row); ++col_num, ++col)
+          row_indices[col] = *col_num;
+      }
+
+      void copy_row (const dealii::SparsityPattern &csp,
+                     const unsigned int             row,
+                     std::vector<int>              &row_indices)
+      {
+        dealii::SparsityPattern::iterator col_num = csp.begin (row);
+        for (unsigned int col=0; col_num != csp.end (row); ++col_num, ++col)
+          row_indices[col] = col_num->column();
+      }
+    }
+  }
+
+
+
   template <typename SparsityType>
   void
   SparsityPattern::reinit (const Epetra_Map   &input_row_map,
@@ -323,12 +352,7 @@ namespace TrilinosWrappers
             continue;
 
           row_indices.resize (row_length, -1);
-
-          typename SparsityType::row_iterator col_num = sp.row_begin (row),
-                                              row_end = sp.row_end(row);
-          for (unsigned int col = 0; col_num != row_end; ++col_num, ++col)
-            row_indices[col] = *col_num;
-
+          internal::copy_row(sp, row, row_indices);
           graph->Epetra_CrsGraph::InsertGlobalIndices (row, row_length,
                                                        &row_indices[0]);
         }
@@ -340,14 +364,9 @@ namespace TrilinosWrappers
             continue;
 
           row_indices.resize (row_length, -1);
-
-          typename SparsityType::row_iterator col_num = sp.row_begin (row),
-                                              row_end = sp.row_end(row);
-          for (unsigned int col = 0; col_num != row_end; ++col_num, ++col)
-            row_indices[col] = *col_num;
-
-          graph->InsertGlobalIndices (1, reinterpret_cast<int *>(&row), row_length,
-                                      &row_indices[0]);
+          internal::copy_row(sp, row, row_indices);
+          graph->InsertGlobalIndices (1, reinterpret_cast<int *>(&row),
+                                      row_length, &row_indices[0]);
         }
 
     compress();
index 03d20c96505e271fa4ac6012c920bf7a8638124c..026398b526aca9d88580526be5dbafb508ea84b3 100644 (file)
@@ -1654,8 +1654,6 @@ namespace MGTools
     BlockSparseMatrix<number> &matrix,
     const bool preserve_symmetry)
   {
-    const unsigned int blocks = matrix.n_block_rows();
-
     Assert (matrix.n_block_rows() == matrix.n_block_cols(),
             ExcNotQuadratic());
     Assert (matrix.get_sparsity_pattern().get_row_indices() ==

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.