]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Change unsigned int to types::global_dof_index.
authorbuerg <buerg@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 13 Aug 2012 07:41:42 +0000 (07:41 +0000)
committerbuerg <buerg@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 13 Aug 2012 07:41:42 +0000 (07:41 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_3@25918 0785d39b-7218-0410-832d-ea1e28bc413d

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

index 0f6dbc72f65da76058e3d377837892642fd74564..1778a57b56196e6c1ab9ac22b9c28a9b412a5622 100644 (file)
@@ -121,7 +121,7 @@ MARKUS source/lac/chunk_sparse_matrix.cc
 MARKUS source/lac/chunk_sparsity_pattern.cc
 MARKUS source/lac/compressed_set_sparsity_pattern.cc
 MARKUS source/lac/compressed_simple_sparsity_pattern.cc
-source/lac/compressed_sparsity_pattern.cc
+MARKUS source/lac/compressed_sparsity_pattern.cc
 WOLFGANG source/lac/constraint_matrix.cc
 source/lac/full_matrix.cc
 source/lac/lapack_full_matrix.cc
@@ -375,7 +375,7 @@ MARKUS include/deal.II/lac/chunk_sparse_matrix.templates.h
 MARKUS include/deal.II/lac/chunk_sparsity_pattern.h
 MARKUS include/deal.II/lac/compressed_set_sparsity_pattern.h
 MARKUS include/deal.II/lac/compressed_simple_sparsity_pattern.h
-include/deal.II/lac/compressed_sparsity_pattern.h
+MARKUS include/deal.II/lac/compressed_sparsity_pattern.h
 WOLFGANG include/deal.II/lac/constraint_matrix.h
 WOLFGANG include/deal.II/lac/constraint_matrix.templates.h
 include/deal.II/lac/eigen.h
index 5d75a5a8bebbc2609e2a20b157271f355156e12a..86fadbd2c4b9ca6e1bf40d2afa74d67c56a3f953 100644 (file)
@@ -136,15 +136,15 @@ class CompressedSimpleSparsityPattern : public Subscriptor
                                       * default argument keeps all
                                       * entries.
                                       */
-    CompressedSimpleSparsityPattern (const unsigned int m,
-                                     const unsigned int n,
+    CompressedSimpleSparsityPattern (const types::global_dof_index m,
+                                     const types::global_dof_index n,
                                      const IndexSet & rowset = IndexSet());
 
                                      /**
                                       * Initialize a square matrix of
                                       * dimension @p n.
                                       */
-    CompressedSimpleSparsityPattern (const unsigned int n);
+    CompressedSimpleSparsityPattern (const types::global_dof_index n);
 
                                      /**
                                       * Copy operator. For this the
@@ -170,8 +170,8 @@ class CompressedSimpleSparsityPattern : public Subscriptor
                                       * default argument keeps all
                                       * entries.
                                       */
-    void reinit (const unsigned int m,
-                 const unsigned int n,
+    void reinit (const types::global_dof_index m,
+                 const types::global_dof_index n,
                  const IndexSet & rowset = IndexSet());
 
                                      /**
@@ -207,8 +207,8 @@ class CompressedSimpleSparsityPattern : 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
@@ -217,17 +217,17 @@ class CompressedSimpleSparsityPattern : 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
@@ -283,14 +283,14 @@ class CompressedSimpleSparsityPattern : 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
@@ -300,15 +300,15 @@ class CompressedSimpleSparsityPattern : public Subscriptor
                                       * index set of rows that we want
                                       * to store.
                                       */
-    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 types::global_dof_index index) const;
 
                                      /**
                                       * Return an iterator that can loop over
@@ -316,12 +316,12 @@ class CompressedSimpleSparsityPattern : 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
                                       * represented by this structure. The
@@ -377,13 +377,13 @@ class CompressedSimpleSparsityPattern : 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;
 
                                      /**
                                       * A set that contains the valid rows.
@@ -420,7 +420,7 @@ class CompressedSimpleSparsityPattern : 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
@@ -452,7 +452,7 @@ class CompressedSimpleSparsityPattern : public Subscriptor
 
 inline
 void
-CompressedSimpleSparsityPattern::Line::add (const unsigned int j)
+CompressedSimpleSparsityPattern::Line::add (const types::global_dof_index j)
 {
                                    // first check the last element (or if line
                                    // is still empty)
@@ -483,7 +483,7 @@ CompressedSimpleSparsityPattern::Line::add (const unsigned int j)
 
 
 inline
-unsigned int
+types::global_dof_index
 CompressedSimpleSparsityPattern::n_rows () const
 {
   return rows;
@@ -492,7 +492,7 @@ CompressedSimpleSparsityPattern::n_rows () const
 
 
 inline
-unsigned int
+types::global_dof_index
 CompressedSimpleSparsityPattern::n_cols () const
 {
   return cols;
@@ -502,8 +502,8 @@ CompressedSimpleSparsityPattern::n_cols () const
 
 inline
 void
-CompressedSimpleSparsityPattern::add (const unsigned int i,
-                                      const unsigned int j)
+CompressedSimpleSparsityPattern::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));
@@ -521,7 +521,7 @@ CompressedSimpleSparsityPattern::add (const unsigned int i,
 template <typename ForwardIterator>
 inline
 void
-CompressedSimpleSparsityPattern::add_entries (const unsigned int row,
+CompressedSimpleSparsityPattern::add_entries (const types::global_dof_index row,
                                               ForwardIterator begin,
                                               ForwardIterator end,
                                               const bool      indices_are_sorted)
@@ -546,7 +546,7 @@ CompressedSimpleSparsityPattern::Line::Line ()
 
 inline
 unsigned int
-CompressedSimpleSparsityPattern::row_length (const unsigned int row) const
+CompressedSimpleSparsityPattern::row_length (const types::global_dof_index row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
   if (rowset.size() > 0 && !rowset.is_element(row))
@@ -561,8 +561,8 @@ CompressedSimpleSparsityPattern::row_length (const unsigned int row) const
 
 inline
 unsigned int
-CompressedSimpleSparsityPattern::column_number (const unsigned int row,
-                                                const unsigned int index) const
+CompressedSimpleSparsityPattern::column_number (const types::global_dof_index row,
+                                                const types::global_dof_index index) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
   Assert( rowset.size() == 0 || rowset.is_element(row), ExcInternalError());
@@ -577,7 +577,7 @@ CompressedSimpleSparsityPattern::column_number (const unsigned int row,
 
 inline
 CompressedSimpleSparsityPattern::row_iterator
-CompressedSimpleSparsityPattern::row_begin (const unsigned int row) const
+CompressedSimpleSparsityPattern::row_begin (const types::global_dof_index row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
   const unsigned int local_row = rowset.size() ? rowset.index_within_set(row) : row;
@@ -588,7 +588,7 @@ CompressedSimpleSparsityPattern::row_begin (const unsigned int row) const
 
 inline
 CompressedSimpleSparsityPattern::row_iterator
-CompressedSimpleSparsityPattern::row_end (const unsigned int row) const
+CompressedSimpleSparsityPattern::row_end (const types::global_dof_index row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
   const unsigned int local_row = rowset.size() ? rowset.index_within_set(row) : row;
index 3283c0d1b27f7a784f71b811df608758754f5873..198d1880a555d40eb920608f953cfcdd30927686 100644 (file)
@@ -231,8 +231,8 @@ CompressedSimpleSparsityPattern (const CompressedSimpleSparsityPattern &s)
 
 
 
-CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const unsigned int m,
-                                                                  const unsigned int n,
+CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const types::global_dof_index m,
+                                                                  const types::global_dof_index n,
                                                                   const IndexSet & rowset_
 )
                 :
@@ -245,7 +245,7 @@ CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const unsigned
 
 
 
-CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const unsigned int n)
+CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const types::global_dof_index n)
                 :
                 rows(0),
                 cols(0),
@@ -271,8 +271,8 @@ CompressedSimpleSparsityPattern::operator = (const CompressedSimpleSparsityPatte
 
 
 void
-CompressedSimpleSparsityPattern::reinit (const unsigned int m,
-                                         const unsigned int n,
+CompressedSimpleSparsityPattern::reinit (const types::global_dof_index m,
+                                         const types::global_dof_index n,
                                          const IndexSet & rowset_)
 {
   rows = m;
@@ -316,8 +316,8 @@ CompressedSimpleSparsityPattern::max_entries_per_row () const
 
 
 bool
-CompressedSimpleSparsityPattern::exists (const unsigned int i,
-                                         const unsigned int j) const
+CompressedSimpleSparsityPattern::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));
@@ -461,11 +461,11 @@ CompressedSimpleSparsityPattern::memory_consumption () const
 
 
 // explicit instantiations
-template void CompressedSimpleSparsityPattern::Line::add_entries(unsigned int *,
-                                                                 unsigned int *,
+template void CompressedSimpleSparsityPattern::Line::add_entries(types::global_dof_index *,
+                                                                 types::global_dof_index *,
                                                                  const bool);
-template void CompressedSimpleSparsityPattern::Line::add_entries(const unsigned int *,
-                                                                 const unsigned int *,
+template void CompressedSimpleSparsityPattern::Line::add_entries(const types::global_dof_index *,
+                                                                 const types::global_dof_index *,
                                                                  const bool);
 #ifndef DEAL_II_VECTOR_ITERATOR_IS_POINTER
 template void CompressedSimpleSparsityPattern::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.