]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Change unsigned int to types::global_dof_index.
authorbuerg <buerg@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 14 Aug 2012 08:08:23 +0000 (08:08 +0000)
committerbuerg <buerg@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 14 Aug 2012 08:08:23 +0000 (08:08 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_3@25964 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/files
deal.II/include/deal.II/lac/compressed_sparsity_pattern.h
deal.II/source/lac/compressed_sparsity_pattern.cc

index 1778a57b56196e6c1ab9ac22b9c28a9b412a5622..db520d86fd96d888faae9cf87e5745a2ee21740b 100644 (file)
@@ -128,7 +128,7 @@ source/lac/lapack_full_matrix.cc
 source/lac/matrix_lib.cc
 source/lac/matrix_out.cc
 source/lac/operator.cc
-source/lac/parallel_vector.cc
+MARKUS source/lac/parallel_vector.cc
 source/lac/petsc_block_sparse_matrix.cc
 source/lac/petsc_full_matrix.cc
 source/lac/petsc_matrix_base.cc
@@ -393,9 +393,9 @@ include/deal.II/lac/matrix_iterator.h
 include/deal.II/lac/matrix_lib.h
 include/deal.II/lac/matrix_lib.templates.h
 include/deal.II/lac/matrix_out.h
-include/deal.II/lac/parallel_block_vector.h
-include/deal.II/lac/parallel_vector.h
-include/deal.II/lac/parallel_vector.templates.h
+MARKUS include/deal.II/lac/parallel_block_vector.h
+MARKUS include/deal.II/lac/parallel_vector.h
+MARKUS include/deal.II/lac/parallel_vector.templates.h
 include/deal.II/lac/petsc_block_sparse_matrix.h
 include/deal.II/lac/petsc_block_vector.h
 include/deal.II/lac/petsc_full_matrix.h
index 2d592e4e2a686d8687340189755e4cf663b298de..88d49e05222389216e75725973c9c72523ef0fdc 100644 (file)
@@ -131,14 +131,14 @@ class CompressedSparsityPattern : public Subscriptor
                                       * matrix with @p m rows and
                                       * @p n columns.
                                       */
-    CompressedSparsityPattern (const unsigned int m,
-                               const unsigned int n);
+    CompressedSparsityPattern (const types::global_dof_index m,
+                               const types::global_dof_index n);
 
                                      /**
                                       * Initialize a square matrix of
                                       * dimension @p n.
                                       */
-    CompressedSparsityPattern (const unsigned int n);
+    CompressedSparsityPattern (const types::global_dof_index n);
 
                                      /**
                                       * Copy operator. For this the
@@ -158,8 +158,8 @@ class CompressedSparsityPattern : public Subscriptor
                                       * max_entries_per_row() nonzero
                                       * entries per row.
                                       */
-    void reinit (const unsigned int m,
-                 const unsigned int n);
+    void reinit (const types::global_dof_index m,
+                 const types::global_dof_index n);
 
                                      /**
                                       * Since this object is kept
@@ -194,8 +194,8 @@ class CompressedSparsityPattern : public Subscriptor
                                       * matrix. If the entry already
                                       * exists, nothing bad happens.
                                       */
-    void add (const unsigned int i,
-              const unsigned int j);
+    void add (const types::global_dof_index i,
+              const types::global_dof_index j);
 
                                      /**
                                       * Add several nonzero entries to the
@@ -204,17 +204,17 @@ class CompressedSparsityPattern : public Subscriptor
                                       * happens.
                                       */
     template <typename ForwardIterator>
-    void add_entries (const unsigned int row,
-                      ForwardIterator    begin,
-                      ForwardIterator    end,
-                      const bool         indices_are_unique_and_sorted = false);
+    void add_entries (const types::global_dof_index row,
+                      ForwardIterator               begin,
+                      ForwardIterator               end,
+                      const bool                    indices_are_unique_and_sorted = false);
 
                                      /**
                                       * Check if a value at a certain
                                       * position may be non-zero.
                                       */
-    bool exists (const unsigned int i,
-                 const unsigned int j) const;
+    bool exists (const types::global_dof_index i,
+                 const types::global_dof_index j) const;
 
                                      /**
                                       * Make the sparsity pattern
@@ -270,27 +270,27 @@ class CompressedSparsityPattern : public Subscriptor
                                       * matrix, which equals the dimension
                                       * of the image space.
                                       */
-    unsigned int n_rows () const;
+    types::global_dof_index n_rows () const;
 
                                      /**
                                       * Return number of columns of this
                                       * matrix, which equals the dimension
                                       * of the range space.
                                       */
-    unsigned int n_cols () const;
+    types::global_dof_index n_cols () const;
 
                                      /**
                                       * Number of entries in a specific row.
                                       */
-    unsigned int row_length (const unsigned int row) const;
+    unsigned int row_length (const types::global_dof_index row) const;
 
                                      /**
                                       * Access to column number field.
                                       * Return the column number of
                                       * the @p indexth entry in @p row.
                                       */
-    unsigned int column_number (const unsigned int row,
-                                const unsigned int index) const;
+    unsigned int column_number (const types::global_dof_index row,
+                                const unsigned int            index) const;
 
                                      /**
                                       * Return an iterator that can loop over
@@ -298,12 +298,12 @@ class CompressedSparsityPattern : public Subscriptor
                                       * row. Dereferencing the iterator yields
                                       * a column index.
                                       */
-    row_iterator row_begin (const unsigned int row) const;
+    row_iterator row_begin (const types::global_dof_index row) const;
 
                                      /**
                                       * Returns the end of the current row.
                                       */
-    row_iterator row_end (const unsigned int row) const;
+    row_iterator row_end (const types::global_dof_index row) const;
 
                                      /**
                                       * Compute the bandwidth of the matrix
@@ -345,13 +345,13 @@ class CompressedSparsityPattern : public Subscriptor
                                       * Number of rows that this sparsity
                                       * structure shall represent.
                                       */
-    unsigned int rows;
+    types::global_dof_index rows;
 
                                      /**
                                       * Number of columns that this sparsity
                                       * structure shall represent.
                                       */
-    unsigned int cols;
+    types::global_dof_index cols;
 
                                      /**
                                       * Store some data for each row
@@ -447,7 +447,7 @@ class CompressedSparsityPattern : public Subscriptor
                                           * Add the given column number to
                                           * this line.
                                           */
-        void add (const unsigned int col_num);
+        void add (const types::global_dof_index col_num);
 
                                          /**
                                           * Add the columns specified by the
@@ -480,7 +480,7 @@ class CompressedSparsityPattern : public Subscriptor
 
 inline
 void
-CompressedSparsityPattern::Line::add (const unsigned int j)
+CompressedSparsityPattern::Line::add (const types::global_dof_index j)
 {
                                    // first check whether this entry is
                                    // already in the cache. if so, we can
@@ -502,7 +502,7 @@ CompressedSparsityPattern::Line::add (const unsigned int j)
 
 
 inline
-unsigned int
+types::global_dof_index
 CompressedSparsityPattern::n_rows () const
 {
   return rows;
@@ -511,7 +511,7 @@ CompressedSparsityPattern::n_rows () const
 
 
 inline
-unsigned int
+types::global_dof_index
 CompressedSparsityPattern::n_cols () const
 {
   return cols;
@@ -521,8 +521,8 @@ CompressedSparsityPattern::n_cols () const
 
 inline
 void
-CompressedSparsityPattern::add (const unsigned int i,
-                                const unsigned int j)
+CompressedSparsityPattern::add (const types::global_dof_index i,
+                                const types::global_dof_index j)
 {
   Assert (i<rows, ExcIndexRange(i, 0, rows));
   Assert (j<cols, ExcIndexRange(j, 0, cols));
@@ -535,7 +535,7 @@ CompressedSparsityPattern::add (const unsigned int i,
 template <typename ForwardIterator>
 inline
 void
-CompressedSparsityPattern::add_entries (const unsigned int row,
+CompressedSparsityPattern::add_entries (const types::global_dof_index row,
                                         ForwardIterator begin,
                                         ForwardIterator end,
                                         const bool      indices_are_sorted)
@@ -557,7 +557,7 @@ CompressedSparsityPattern::Line::Line ()
 
 inline
 unsigned int
-CompressedSparsityPattern::row_length (const unsigned int row) const
+CompressedSparsityPattern::row_length (const types::global_dof_index row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
 
@@ -570,8 +570,8 @@ CompressedSparsityPattern::row_length (const unsigned int row) const
 
 inline
 unsigned int
-CompressedSparsityPattern::column_number (const unsigned int row,
-                                          const unsigned int index) const
+CompressedSparsityPattern::column_number (const types::global_dof_index row,
+                                          const unsigned int            index) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
   Assert (index < lines[row].entries.size(),
@@ -586,7 +586,7 @@ CompressedSparsityPattern::column_number (const unsigned int row,
 
 inline
 CompressedSparsityPattern::row_iterator
-CompressedSparsityPattern::row_begin (const unsigned int row) const
+CompressedSparsityPattern::row_begin (const types::global_dof_index row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
 
@@ -599,7 +599,7 @@ CompressedSparsityPattern::row_begin (const unsigned int row) const
 
 inline
 CompressedSparsityPattern::row_iterator
-CompressedSparsityPattern::row_end (const unsigned int row) const
+CompressedSparsityPattern::row_end (const types::global_dof_index row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
   return lines[row].entries.end();
index de69bcc8f85283e7219aa52a390526573e797db2..2551b22d23375b9fc404af0b0dafb54022b8b449 100644 (file)
@@ -338,8 +338,8 @@ CompressedSparsityPattern (const CompressedSparsityPattern &s)
 
 
 
-CompressedSparsityPattern::CompressedSparsityPattern (const unsigned int m,
-                                                      const unsigned int n)
+CompressedSparsityPattern::CompressedSparsityPattern (const types::global_dof_index m,
+                                                      const types::global_dof_index n)
                 :
                 rows(0),
                 cols(0)
@@ -349,7 +349,7 @@ CompressedSparsityPattern::CompressedSparsityPattern (const unsigned int m,
 
 
 
-CompressedSparsityPattern::CompressedSparsityPattern (const unsigned int n)
+CompressedSparsityPattern::CompressedSparsityPattern (const types::global_dof_index n)
                 :
                 rows(0),
                 cols(0)
@@ -374,8 +374,8 @@ CompressedSparsityPattern::operator = (const CompressedSparsityPattern &s)
 
 
 void
-CompressedSparsityPattern::reinit (const unsigned int m,
-                                   const unsigned int n)
+CompressedSparsityPattern::reinit (const types::global_dof_index m,
+                                   const types::global_dof_index n)
 {
   rows = m;
   cols = n;
@@ -417,8 +417,8 @@ CompressedSparsityPattern::max_entries_per_row () const
 
 
 bool
-CompressedSparsityPattern::exists (const unsigned int i,
-                                   const unsigned int j) const
+CompressedSparsityPattern::exists (const types::global_dof_index i,
+                                   const types::global_dof_index j) const
 {
   Assert (i<rows, ExcIndexRange(i, 0, rows));
   Assert (j<cols, ExcIndexRange(j, 0, cols));
@@ -548,11 +548,11 @@ CompressedSparsityPattern::n_nonzero_elements () const
 
 
 // explicit instantiations
-template void CompressedSparsityPattern::Line::add_entries(unsigned int *,
-                                                           unsigned int *,
+template void CompressedSparsityPattern::Line::add_entries(types::global_dof_index *,
+                                                           types::global_dof_index *,
                                                            const bool);
-template void CompressedSparsityPattern::Line::add_entries(const unsigned int *,
-                                                           const unsigned int *,
+template void CompressedSparsityPattern::Line::add_entries(const types::global_dof_index *,
+                                                           const types::global_dof_index *,
                                                            const bool);
 #ifndef DEAL_II_VECTOR_ITERATOR_IS_POINTER
 template void CompressedSparsityPattern::Line::

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.