]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Convert unsigned int to types::global_dof_index.
authorturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 28 Feb 2013 23:12:22 +0000 (23:12 +0000)
committerturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 28 Feb 2013 23:12:22 +0000 (23:12 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28653 0785d39b-7218-0410-832d-ea1e28bc413d

35 files changed:
deal.II/include/deal.II/base/index_set.h
deal.II/include/deal.II/base/memory_consumption.h
deal.II/include/deal.II/dofs/dof_accessor.templates.h
deal.II/include/deal.II/dofs/dof_handler.h
deal.II/include/deal.II/dofs/dof_objects.h
deal.II/include/deal.II/fe/fe_base.h
deal.II/include/deal.II/fe/fe_values.h
deal.II/include/deal.II/hp/dof_handler.h
deal.II/include/deal.II/hp/dof_objects.h
deal.II/include/deal.II/lac/compressed_sparsity_pattern.h
deal.II/include/deal.II/lac/sparse_direct.h
deal.II/include/deal.II/lac/sparsity_pattern.h
deal.II/include/deal.II/matrix_free/dof_info.h
deal.II/include/deal.II/matrix_free/dof_info.templates.h
deal.II/include/deal.II/matrix_free/matrix_free.h
deal.II/include/deal.II/matrix_free/matrix_free.templates.h
deal.II/include/deal.II/meshworker/dof_info.h
deal.II/include/deal.II/meshworker/vector_selector.h
deal.II/include/deal.II/meshworker/vector_selector.templates.h
deal.II/include/deal.II/numerics/solution_transfer.h
deal.II/include/deal.II/numerics/vector_tools.templates.h
deal.II/source/dofs/block_info.cc
deal.II/source/dofs/dof_handler.cc
deal.II/source/dofs/dof_handler.inst.in
deal.II/source/dofs/dof_objects.inst.in
deal.II/source/dofs/dof_tools.cc
deal.II/source/fe/fe_values.inst.in
deal.II/source/lac/chunk_sparse_matrix.inst.in
deal.II/source/lac/compressed_sparsity_pattern.cc
deal.II/source/lac/constraint_matrix.inst.pl
deal.II/source/lac/full_matrix.inst.in
deal.II/source/lac/sparse_direct.cc
deal.II/source/numerics/matrix_tools.inst.in
deal.II/source/numerics/solution_transfer.cc
deal.II/source/numerics/vector_tools.inst.in

index 4d650aafc431c229793648c6dde0edb36318fae6..6fe0a6b2ed3483215025307849a99c859bd08dcd 100644 (file)
@@ -908,8 +908,8 @@ IndexSet::nth_index_in_set (const unsigned int n) const
 
 
 inline
-types::global_dof_index
-IndexSet::index_within_set (const unsigned int n) const
+unsigned int
+IndexSet::index_within_set (const types::global_dof_index n) const
 {
   // to make this call thread-safe, compress()
   // must not be called through this function
index 619e3ba5d99c95b02ba2deeeff2ea79f5a4f52bf..e9c854c4c61610670d80536fc45825e21ea8c2b5 100644 (file)
@@ -152,6 +152,14 @@ namespace MemoryConsumption
   inline
   std::size_t memory_consumption (const unsigned int);
 
+  /**
+   * Determine the amount of memory
+   * in bytes consumed by a <tt>unsigned long long int</tt>
+   * variable.
+   */
+  inline
+  std::size_t memory_consumption (const unsigned long long int);
+
   /**
    * Determine the amount of memory
    * in bytes consumed by a <tt>float</tt>
@@ -459,7 +467,7 @@ namespace MemoryConsumption
   {
     return sizeof(int);
   }
-
+  
 
 
   inline
@@ -468,6 +476,14 @@ namespace MemoryConsumption
     return sizeof(unsigned int);
   }
 
+  
+
+  inline
+  std::size_t memory_consumption (const unsigned long long int)
+  {
+    return sizeof(unsigned long long int);
+  }
+
 
 
   inline
index 3cac19305566cd3122271876e661f4b784de2307..9c49af18e8b9faebeec5d984bca0e88a63cb3f38 100644 (file)
@@ -1434,7 +1434,7 @@ namespace internal
       static
       void set_mg_dof_indices (const dealii::DoFAccessor<1,DH,lda> &,
                                const int,
-                               const std::vector<unsigned int> &,
+                               const std::vector<types::global_dof_index> &,
                                const unsigned int)
       {
         AssertThrow (false, ExcNotImplemented ()); //TODO[TH]: implement
@@ -1446,11 +1446,11 @@ namespace internal
       static
       void set_mg_dof_indices (dealii::DoFAccessor<2, DH,lda> &accessor,
                                const int level,
-                               const std::vector<unsigned int> &dof_indices,
+                               const std::vector<types::global_dof_index> &dof_indices,
                                const unsigned int fe_index)
       {
         const FiniteElement<DH::dimension, DH::space_dimension> &fe = accessor.get_dof_handler ().get_fe ()[fe_index];
-        std::vector<unsigned int>::const_iterator next = dof_indices.begin ();
+        std::vector<types::global_dof_index>::const_iterator next = dof_indices.begin ();
 
         for (unsigned int vertex = 0; vertex < GeometryInfo<2>::vertices_per_cell; ++vertex)
           for (unsigned int dof = 0; dof < fe.dofs_per_vertex; ++dof)
@@ -1472,7 +1472,7 @@ namespace internal
       static
       void set_mg_dof_indices (const dealii::DoFAccessor<3, DH,lda> &,
                                const int,
-                               const std::vector<unsigned int> &,
+                               const std::vector<types::global_dof_index> &,
                                const unsigned int)
       {
         AssertThrow (false, ExcNotImplemented ()); //TODO[TH]: implement
@@ -3547,7 +3547,7 @@ DoFCellAccessor<DH,lda>::face (const unsigned int i) const
 template <class DH, bool lda>
 inline
 void
-DoFCellAccessor<DH,lda>::get_dof_indices (std::vector<unsigned int> &dof_indices) const
+DoFCellAccessor<DH,lda>::get_dof_indices (std::vector<types::global_dof_index> &dof_indices) const
 {
   Assert (this->is_artificial() == false,
           ExcMessage ("Can't ask for DoF indices on artificial cells."));
index 747665d0dce223165165cf81aa7be7f1a32963ca..0c3e86b613eedfc89632c5ff05c7a3ccc5110c8e 100644 (file)
@@ -232,7 +232,7 @@ public:
    * certain value, but rather take
    * its symbolic name.
    */
-  static const unsigned int invalid_dof_index = numbers::invalid_unsigned_int;
+  static const types::global_dof_index invalid_dof_index = numbers::invalid_dof_index;
 
   /**
    * The default index of the
@@ -1082,7 +1082,7 @@ DoFHandler<dim,spacedim>::n_dofs () const
 
 template<int dim, int spacedim>
 inline
-unsigned int DoFHandler<dim, spacedim>::n_dofs (const unsigned int level) const
+types::global_dof_index DoFHandler<dim, spacedim>::n_dofs (const unsigned int level) const
 {
   Assert(has_level_dofs(), ExcMessage("n_dofs(level) can only be called after distribute_mg_dofs()"));
   Assert (level < mg_number_cache.size (), ExcInvalidLevel (level));
@@ -1231,7 +1231,7 @@ void DoFHandler<dim,spacedim>::load (Archive &ar,
 
 template<int dim, int spacedim>
 inline
-unsigned int DoFHandler<dim, spacedim>::MGVertexDoFs::get_index (
+types::global_dof_index DoFHandler<dim, spacedim>::MGVertexDoFs::get_index (
   const unsigned int level,
   const unsigned int dof_number) const
 {
@@ -1245,7 +1245,7 @@ inline
 void DoFHandler<dim, spacedim>::MGVertexDoFs::set_index (
   const unsigned int level,
   const unsigned int dof_number,
-  const unsigned int index)
+  const types::global_dof_index index)
 {
   Assert ((level >= coarsest_level) && (level <= finest_level), ExcInvalidLevel (level));
   indices[indices_offset[level - coarsest_level] + dof_number] = index;
index 66ed7f8315a802c87379811e1e75c4fe416145b0..f7e7eb8302295beaa869c011ade863c0d29dc811 100644 (file)
@@ -192,7 +192,7 @@ namespace internal
     inline
     unsigned int
     DoFObjects<dim>::n_active_fe_indices (const dealii::DoFHandler<dh_dim,spacedim> &,
-                                          const unsigned) const
+                                          const types::global_dof_index) const
     {
       return 1;
     }
index ddd8e1565d4ed2874d6a9b0ef497e6b15e8aff12..0ad4a65f8603740545053dbbafd93787477a2a6e 100644 (file)
@@ -206,13 +206,13 @@ public:
   /**
    * Number of degrees of freedom on a vertex.
    */
-  const unsigned int dofs_per_vertex;
+  const types::global_dof_index dofs_per_vertex;
 
   /**
    * Number of degrees of freedom in a line; not including the degrees of
    * freedom on the vertices of the line.
    */
-  const unsigned int dofs_per_line;
+  const types::global_dof_index dofs_per_line;
 
   /**
    * Number of degrees of freedom in a quadrilateral; not including the
index 85eab8712c225e1c2d49613c2438f5ec1b506feb..abb1dcfed0fb77dc2ebaeced892be19404689ce2 100644 (file)
@@ -4783,7 +4783,7 @@ inline
 void
 FEValuesBase<dim,spacedim>::get_function_grads (
   const InputVector &fe_function,
-  const VectorSlice<const std::vector<unsigned int> > &indices,
+  const VectorSlice<const std::vector<types::global_dof_index> > &indices,
   std::vector<Tensor<1,spacedim> > &values) const
 {
   get_function_gradients(fe_function, indices, values);
@@ -4810,7 +4810,7 @@ inline
 void
 FEValuesBase<dim,spacedim>::get_function_grads (
   const InputVector &fe_function,
-  const VectorSlice<const std::vector<unsigned int> > &indices,
+  const VectorSlice<const std::vector<types::global_dof_index> > &indices,
   std::vector<std::vector<Tensor<1,spacedim> > > &values,
   bool q_points_fastest) const
 {
index f4136f5c43a63a2a948ba20d82170223c39125f1..751da3e0c472fcb0bc29269a64ce9b248c2a7cbd 100644 (file)
@@ -454,7 +454,7 @@ namespace hp
      * cells are also not necessarily
      * included.
      */
-    unsigned int n_locally_owned_dofs() const;
+    types::global_dof_index n_locally_owned_dofs() const;
 
     /**
      * Return an IndexSet describing
@@ -512,7 +512,7 @@ namespace hp
      * then the vector has a single
      * element equal to n_dofs().
      */
-    const std::vector<unsigned int> &
+    const std::vector<types::global_dof_index> &
     n_locally_owned_dofs_per_processor () const;
 
     /**
index cfcb837f6022b0c086d47c5099a82bb959d3b9c0..145f394faa6fb5cc7121d5b69919a7e5fbfa98a1 100644 (file)
@@ -210,7 +210,7 @@ namespace internal
        * on this object.
        */
       template <int dimm, int spacedim>
-      unsigned int
+      types::global_dof_index
       nth_active_fe_index (const dealii::hp::DoFHandler<dimm,spacedim> &dof_handler,
                            const unsigned int               obj_level,
                            const unsigned int               obj_index,
@@ -305,7 +305,7 @@ namespace internal
           // find a set for this
           // particular fe_index
           const types::global_dof_index starting_offset = dof_offsets[obj_index];
-          const unsigned int *pointer        = &dofs[starting_offset];
+          const types::global_dof_index *pointer        = &dofs[starting_offset];
           while (true)
             {
               Assert (*pointer != numbers::invalid_unsigned_int,
@@ -387,7 +387,7 @@ namespace internal
           // find a set for this
           // particular fe_index
           const types::global_dof_index starting_offset = dof_offsets[obj_index];
-          unsigned int      *pointer         = &dofs[starting_offset];
+          types::global_dof_index      *pointer         = &dofs[starting_offset];
           while (true)
             {
               Assert (*pointer != numbers::invalid_unsigned_int,
index 9ecc0ca4cc31d4842ac3b5df0245b7ab30df2644..37994cd9cfd93019978c0e6736f7bfca26586968 100644 (file)
@@ -430,7 +430,7 @@ private:
      * the cache. This array is always
      * kept sorted.
      */
-    mutable std::vector<unsigned int> entries;
+    mutable std::vector<size_type> entries;
 
     /**
      * Cache of entries that have not yet
index 9c893d4638a666bba7b6a941732c2e95f9213eed..5149d54f5a79b17c19671c79fec76ff4f44a051c 100644 (file)
@@ -978,15 +978,15 @@ private:
    * Call the <tt>ma47ad</tt> function
    * with the given args.
    */
-  void call_ma47ad (const size_type *n_rows,
-                    const size_type *n_nonzero_elements,
-                    size_type       *row_numbers,
-                    size_type       *column_numbers,
-                    size_type       *IW,
-                    const size_type *LIW,
-                    size_type       *KEEP,
-                    const size_type *ICNTL,
-                    int             *INFO);
+  void call_ma47ad (const size_type    *n_rows,
+                    const size_type    *n_nonzero_elements,
+                    size_type          *row_numbers,
+                    size_type          *column_numbers,
+                    size_type          *IW,
+                    const size_type    *LIW,
+                    size_type          *KEEP,
+                    const unsigned int *ICNTL,
+                    int                *INFO);
 
   /**
    * Call the <tt>ma47bd</tt> function
index 00f7433ca27476a9323110efc0d59f2cb24f8e42..61cae06570cdb16e1574c1c0b9c5c77b23efb8e3 100644 (file)
@@ -1801,7 +1801,7 @@ SparsityPattern::n_nonzero_elements () const
 template <class Archive>
 inline
 void
-SparsityPattern::save (Archive &ar, const size_type) const
+SparsityPattern::save (Archive &ar, const unsigned int) const
 {
   // forward to serialization function in the base class.
   ar   &static_cast<const Subscriptor &>(*this);
@@ -1817,7 +1817,7 @@ SparsityPattern::save (Archive &ar, const size_type) const
 template <class Archive>
 inline
 void
-SparsityPattern::load (Archive &ar, const size_type)
+SparsityPattern::load (Archive &ar, const unsigned int)
 {
   // forward to serialization function in the base class.
   ar   &static_cast<Subscriptor &>(*this);
index 142268d83b8b9e7c256e935f772adf193761127d..1c8f9f8539330b5314f95e5f348438a30b19cf45 100644 (file)
@@ -154,7 +154,7 @@ namespace internal
        * assigned the correct index after all the ghost indices have been
        * collected by the call to @p assign_ghosts.
        */
-      void read_dof_indices (const std::vector<unsigned int> &local_indices,
+      void read_dof_indices (const std::vector<types::global_dof_index> &local_indices,
                              const std::vector<unsigned int> &lexicographic_inv,
                              const ConstraintMatrix          &constraints,
                              const unsigned int               cell_number,
@@ -491,7 +491,7 @@ namespace internal
 
 
     inline
-    const unsigned int *
+    const types::global_dof_index *
     DoFInfo::begin_indices_plain (const unsigned int row) const
     {
       // if we have no constraints, should take the data from dof_indices
@@ -513,7 +513,7 @@ namespace internal
 
 
     inline
-    const unsigned int *
+    const types::global_dof_index *
     DoFInfo::end_indices_plain (const unsigned int row) const
     {
       return begin_indices_plain(row) +
index 9a28ef5686d99dbcd93049f5af81e1b297a21abf..bbc15a0e9a787c41a362c6b482eb30d1156858a9 100644 (file)
@@ -1641,7 +1641,7 @@ not_connect:
     namespace internal
     {
       // rudimentary version of a vector that keeps entries always ordered
-      class ordered_vector : public std::vector<unsigned int>
+      class ordered_vector : public std::vector<types::global_dof_index>
       {
       public:
         ordered_vector ()
@@ -1649,20 +1649,20 @@ not_connect:
           reserve (2000);
         }
 
-        void reserve (const unsigned int size)
+        void reserve (const types::global_dof_index size)
         {
           if (size > 0)
-            this->std::vector<unsigned int>::reserve (size);
+            this->std::vector<types::global_dof_index>::reserve (size);
         }
 
 
         // insert a given entry. dat is a pointer within this vector (the user
         // needs to make sure that it really stays there)
-        void insert (const unsigned int entry,
-                     std::vector<unsigned int>::iterator &dat)
+        void insert (const types::global_dof_index entry,
+                     std::vector<types::global_dof_index>::iterator &dat)
         {
-          AssertIndexRange (static_cast<unsigned int>(dat - begin()), size()+1);
-          AssertIndexRange (static_cast<unsigned int>(end() - dat), size()+1);
+          AssertIndexRange (static_cast<types::global_dof_index>(dat - begin()), size()+1);
+          AssertIndexRange (static_cast<types::global_dof_index>(end() - dat), size()+1);
           AssertIndexRange (size(), capacity());
           while (dat != end() && *dat < entry)
             ++dat;
@@ -1674,7 +1674,7 @@ not_connect:
             }
           else if (*dat > entry)
             {
-              dat = this->std::vector<unsigned int>::insert (dat, entry);
+              dat = this->std::vector<types::global_dof_index>::insert (dat, entry);
               ++dat;
             }
           else
@@ -1694,17 +1694,18 @@ not_connect:
      CompressedSimpleSparsityPattern &connectivity) const
     {
       AssertDimension (row_starts.size()-1, size_info.n_active_cells);
-      const unsigned int n_rows = (vector_partitioner->local_range().second-
+      const types::global_dof_index n_rows = 
+                                  (vector_partitioner->local_range().second-
                                    vector_partitioner->local_range().first)
                                   + vector_partitioner->ghost_indices().n_elements();
-      const unsigned int n_blocks = (do_blocking == true) ?
+      const types::global_dof_index n_blocks = (do_blocking == true) ?
                                     task_info.n_blocks : size_info.n_active_cells;
 
       // first determine row lengths
-      std::vector<unsigned int> row_lengths(n_rows);
+      std::vector<types::global_dof_index> row_lengths(n_rows);
       unsigned int cell_start = 0, mcell_start = 0;
       std::vector<types::global_dof_index> scratch;
-      for (unsigned int block = 0; block < n_blocks; ++block)
+      for (types::global_dof_index block = 0; block < n_blocks; ++block)
         {
           // if we have the blocking variant (used in the coloring scheme), we
           // want to build a graph with the blocks with interaction with
@@ -1748,7 +1749,7 @@ not_connect:
         }
 
       // disregard dofs that only sit on one cell
-      for (unsigned int row=0; row<n_rows; ++row)
+      for (types::global_dof_index row=0; row<n_rows; ++row)
         if (row_lengths[row] == 1)
           row_lengths[row] = 0;
 
index 7ba86c6359f81d8cbe2f98946222ce85d20cf63c..f2dd4b2b3f361965f807b176629a2418e27e14da 100644 (file)
@@ -556,14 +556,14 @@ public:
    * vector, not in global numbers. In addition, it only returns the indices
    * for degrees of freedom that are owned locally, not for ghosts.
    */
-  const std::vector<unsigned int> &
+  const std::vector<types::global_dof_index> &
   get_constrained_dofs (const unsigned int fe_component = 0) const;
 
   /**
    * Calls renumber_dofs function in dof info which renumbers the degrees
    * of freedom according to the ordering for parallelization.
    */
-  void renumber_dofs (std::vector<unsigned int> &renumbering,
+  void renumber_dofs (std::vector<types::global_dof_index> &renumbering,
                       const unsigned int vector_component = 0);
 
   //@}
@@ -970,7 +970,7 @@ MatrixFree<dim,Number>::get_vector_partitioner (const unsigned int comp) const
 
 template <int dim, typename Number>
 inline
-const std::vector<unsigned int> &
+const std::vector<types::global_dof_index> &
 MatrixFree<dim,Number>::get_constrained_dofs (const unsigned int comp) const
 {
   AssertIndexRange (comp, n_components());
@@ -1157,7 +1157,7 @@ MatrixFree<dim,Number>::create_cell_subrange_hp_by_index
 template <int dim, typename Number>
 inline
 void
-MatrixFree<dim,Number>::renumber_dofs (std::vector<unsigned int> &renumbering,
+MatrixFree<dim,Number>::renumber_dofs (std::vector<types::global_dof_index> &renumbering,
                                        const unsigned int vector_component)
 {
   AssertIndexRange(vector_component, dof_info.size());
index ba556a02e9482fb004d4c9f9156dfdd7fcd8b31f..3c38036ffa2f37ca6d43e7f65c3a945e0887aed2 100644 (file)
@@ -411,7 +411,7 @@ void MatrixFree<dim,Number>::initialize_indices
   AssertDimension (n_fe, locally_owned_set.size());
   AssertDimension (n_fe, constraint.size());
 
-  std::vector<unsigned int> local_dof_indices;
+  std::vector<types::global_dof_index> local_dof_indices;
   std::vector<std::vector<unsigned int> > ghost_dofs(n_fe);
   std::vector<std::vector<std::vector<unsigned int> > > lexicographic_inv(n_fe);
 
@@ -684,7 +684,7 @@ void MatrixFree<dim,Number>::initialize_indices
   }
 
   // set constraint pool from the std::map and reorder the indices
-  typename std::map<std::vector<double>, unsigned int,
+  typename std::map<std::vector<double>, types::global_dof_index,
            internal::MatrixFreeFunctions::FPArrayComparator<double> >::iterator
            it = constraint_values.constraints.begin(),
            end = constraint_values.constraints.end();
index ecce7cb5bfa8c5861f4a1d100ff682fd4eac94c1..e1be3f30b218af8c6ab8acc08bc01a8fc85cb890 100644 (file)
@@ -298,7 +298,7 @@ namespace MeshWorker
   template <class DH>
   DoFInfo<dim,spacedim,number>::DoFInfo(const DH &dof_handler)
   {
-    std::vector<unsigned int> aux(1);
+    std::vector<types::global_dof_index> aux(1);
     aux[0] = dof_handler.get_fe().dofs_per_cell;
     aux_local_indices.reinit(aux);
   }
index 0edf1df4f64312e98d78029e24a6d8dca623c02a..80f32264c953f85e2d7c3e32f2fc63e9f3a590cd 100644 (file)
@@ -290,7 +290,7 @@ namespace MeshWorker
       std::vector<std::vector<std::vector<Tensor<1,dim> > > > &gradients,
       std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
       const FEValuesBase<dim,spacedim> &fe,
-      const std::vector<unsigned int> &index,
+      const std::vector<types::global_dof_index> &index,
       const unsigned int component,
       const unsigned int n_comp,
       const unsigned int start,
@@ -313,7 +313,7 @@ namespace MeshWorker
       std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
       const FEValuesBase<dim,spacedim> &fe,
       const unsigned int level,
-      const std::vector<unsigned int> &index,
+      const std::vector<types::global_dof_index> &index,
       const unsigned int component,
       const unsigned int n_comp,
       const unsigned int start,
@@ -382,7 +382,7 @@ namespace MeshWorker
       std::vector<std::vector<std::vector<Tensor<1,dim> > > > &gradients,
       std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
       const FEValuesBase<dim,spacedim> &fe,
-      const std::vector<unsigned int> &index,
+      const std::vector<types::global_dof_index> &index,
       const unsigned int component,
       const unsigned int n_comp,
       const unsigned int start,
@@ -455,7 +455,7 @@ namespace MeshWorker
       std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
       const FEValuesBase<dim,spacedim> &fe,
       const unsigned int level,
-      const std::vector<unsigned int> &index,
+      const std::vector<types::global_dof_index> &index,
       const unsigned int component,
       const unsigned int n_comp,
       const unsigned int start,
index 36a2dbb1ee686f1b3fcb06b145cbf3e6040ae18e..1490db53bc3d96b009a750631a12ba230c5921cd 100644 (file)
@@ -42,7 +42,7 @@ namespace MeshWorker
     std::vector<std::vector<std::vector<Tensor<1,dim> > > > &,
     std::vector<std::vector<std::vector<Tensor<2,dim> > > > &,
     const FEValuesBase<dim,spacedim> &,
-    const std::vector<unsigned int> &,
+    const std::vector<types::global_dof_index> &,
     const unsigned int,
     const unsigned int,
     const unsigned int,
@@ -60,7 +60,7 @@ namespace MeshWorker
     std::vector<std::vector<std::vector<Tensor<2,dim> > > > &,
     const FEValuesBase<dim,spacedim> &,
     const unsigned int,
-    const std::vector<unsigned int> &,
+    const std::vector<types::global_dof_index> &,
     const unsigned int,
     const unsigned int,
     const unsigned int,
@@ -110,7 +110,7 @@ namespace MeshWorker
     std::vector<std::vector<std::vector<Tensor<1,dim> > > > &gradients,
     std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
     const FEValuesBase<dim,spacedim> &fe,
-    const std::vector<unsigned int> &index,
+    const std::vector<types::global_dof_index> &index,
     const unsigned int component,
     const unsigned int n_comp,
     const unsigned int start,
@@ -194,7 +194,7 @@ namespace MeshWorker
     std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
     const FEValuesBase<dim,spacedim> &fe,
     const unsigned int level,
-    const std::vector<unsigned int> &index,
+    const std::vector<types::global_dof_index> &index,
     const unsigned int component,
     const unsigned int n_comp,
     const unsigned int start,
index 74614686a09abb1290400ea625e5befe45f84a08..e42b9261f8f3a07f111c38d5690bcdedb617b0ae 100644 (file)
@@ -432,7 +432,7 @@ private:
   struct Pointerstruct
   {
     Pointerstruct() : indices_ptr(0), dof_values_ptr(0), active_fe_index(0) {};
-    Pointerstruct(std::vector<unsigned int> *indices_ptr_in,
+    Pointerstruct(std::vector<types::global_dof_index> *indices_ptr_in,
                   const unsigned int active_fe_index_in = 0)
       :
       indices_ptr(indices_ptr_in),
@@ -445,7 +445,7 @@ private:
       active_fe_index(active_fe_index_in) {};
     std::size_t memory_consumption () const;
 
-    std::vector<unsigned int>    *indices_ptr;
+    std::vector<types::global_dof_index>    *indices_ptr;
     std::vector<Vector<typename VECTOR::value_type> > *dof_values_ptr;
     unsigned int active_fe_index;
   };
index 346401eb9d9b0eaed8d2f3d411f4e3800a028c14..8081e8f2ae2615c35135df142aa00d010be56cfe 100644 (file)
@@ -3366,7 +3366,7 @@ namespace VectorTools
 
     std::vector<bool> dofs_processed (dofs_per_face);
     std::vector<double> dof_values (dofs_per_face);
-    std::vector<unsigned int> face_dof_indices (dofs_per_face);
+    std::vector<types::global_dof_index> face_dof_indices (dofs_per_face);
     typename DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active ();
 
     switch (dim)
@@ -3943,7 +3943,7 @@ namespace VectorTools
                                             const Function<dim> &,
                                             const std::vector<DerivativeForm<1,dim,dim> > &,
                                             std::vector<double> &,
-                                            std::vector<unsigned int> &)
+                                            std::vector<types::global_dof_index> &)
     {
       Assert (false, ExcNotImplemented ());
     }
index a81c86c2527e4db534566b905792c7f8ef511a6d..9e7dd902f8df203e910fd853dcbf9ce6f10b8fc0 100644 (file)
@@ -30,14 +30,14 @@ BlockInfo::initialize(const DoFHandler<dim, spacedim> &dof, bool levels_only, bo
   if (!levels_only && dof.has_active_dofs())
     {
       const FiniteElement<dim, spacedim> &fe = dof.get_fe();
-      std::vector<unsigned int> sizes(fe.n_blocks());
+      std::vector<types::global_dof_index> sizes(fe.n_blocks());
       DoFTools::count_dofs_per_block(dof, sizes);
       bi_global.reinit(sizes);
     }
 
   if (!active_only && dof.has_level_dofs())
     {
-      std::vector<std::vector<unsigned int> > sizes (dof.get_tria ().n_levels ());
+      std::vector<std::vector<types::global_dof_index> > sizes (dof.get_tria ().n_levels ());
 
       for (unsigned int i = 0; i < sizes.size (); ++i)
         sizes[i].resize (dof.get_fe ().n_blocks ());
@@ -56,7 +56,7 @@ void
 BlockInfo::initialize_local(const DoFHandler<dim, spacedim> &dof)
 {
   const FiniteElement<dim, spacedim> &fe = dof.get_fe();
-  std::vector<unsigned int> sizes(fe.n_blocks());
+  std::vector<types::global_dof_index> sizes(fe.n_blocks());
 
   base_elements.resize(fe.n_blocks());
 
index dffe4724f54f78696710af5758b047fd049eb12f..763fd9758c1f3f4d47975ceefab60b4149070d33 100644 (file)
@@ -120,7 +120,7 @@ namespace internal
         // nodes)
         // count lines -> 28 (don't forget to count
         // mother and children separately!)
-        unsigned int max_couplings;
+        types::global_dof_index max_couplings;
         switch (dof_handler.tria->max_adjacent_cells())
           {
           case 4:
@@ -223,7 +223,7 @@ namespace internal
         const unsigned int max_adjacent_cells
           = dof_handler.tria->max_adjacent_cells();
 
-        unsigned int max_couplings;
+        types::global_dof_index max_couplings;
         if (max_adjacent_cells <= 8)
           max_couplings=7*7*7*dof_handler.selected_fe->dofs_per_vertex +
                         7*6*7*3*dof_handler.selected_fe->dofs_per_line +
@@ -364,7 +364,7 @@ namespace internal
         for (unsigned int i = 0; i < n_levels; ++i)
           {
             dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<1>);
-            dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<unsigned int> (tria.n_raw_lines (i) * dofs_per_line, DoFHandler<1>::invalid_dof_index);
+            dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<types::global_dof_index> (tria.n_raw_lines (i) * dofs_per_line, DoFHandler<1>::invalid_dof_index);
           }
 
         const unsigned int &n_vertices = tria.n_vertices ();
@@ -420,11 +420,11 @@ namespace internal
         for (unsigned int i = 0; i < n_levels; ++i)
           {
             dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<2>);
-            dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<unsigned int> (tria.n_raw_quads (i) * fe.dofs_per_quad, DoFHandler<2>::invalid_dof_index);
+            dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<types::global_dof_index> (tria.n_raw_quads (i) * fe.dofs_per_quad, DoFHandler<2>::invalid_dof_index);
           }
 
         dof_handler.mg_faces = new internal::DoFHandler::DoFFaces<2>;
-        dof_handler.mg_faces->lines.dofs = std::vector<unsigned int> (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<2>::invalid_dof_index);
+        dof_handler.mg_faces->lines.dofs = std::vector<types::global_dof_index> (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<2>::invalid_dof_index);
 
         const unsigned int &n_vertices = tria.n_vertices ();
 
@@ -479,12 +479,12 @@ namespace internal
         for (unsigned int i = 0; i < n_levels; ++i)
           {
             dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<3>);
-            dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<unsigned int> (tria.n_raw_hexs (i) * fe.dofs_per_hex, DoFHandler<3>::invalid_dof_index);
+            dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<types::global_dof_index> (tria.n_raw_hexs (i) * fe.dofs_per_hex, DoFHandler<3>::invalid_dof_index);
           }
 
         dof_handler.mg_faces = new internal::DoFHandler::DoFFaces<3>;
-        dof_handler.mg_faces->lines.dofs = std::vector<unsigned int> (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<3>::invalid_dof_index);
-        dof_handler.mg_faces->quads.dofs = std::vector<unsigned int> (tria.n_raw_quads () * fe.dofs_per_quad, DoFHandler<3>::invalid_dof_index);
+        dof_handler.mg_faces->lines.dofs = std::vector<types::global_dof_index> (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<3>::invalid_dof_index);
+        dof_handler.mg_faces->quads.dofs = std::vector<types::global_dof_index> (tria.n_raw_quads () * fe.dofs_per_quad, DoFHandler<3>::invalid_dof_index);
 
         const unsigned int &n_vertices = tria.n_vertices ();
 
@@ -1283,7 +1283,7 @@ void DoFHandler<1>::renumber_dofs (const unsigned int level,
       for (unsigned int d=0; d<this->get_fe().dofs_per_vertex; ++d)
         i->set_index (level, d, new_numbers[i->get_index (level, d)]);
 
-  for (std::vector<unsigned int>::iterator i=mg_levels[level]->dof_object.dofs.begin();
+  for (std::vector<types::global_dof_index>::iterator i=mg_levels[level]->dof_object.dofs.begin();
        i!=mg_levels[level]->dof_object.dofs.end(); ++i)
     {
       if (*i != DoFHandler<1>::invalid_dof_index)
@@ -1342,7 +1342,7 @@ void DoFHandler<2>::renumber_dofs (const unsigned int  level,
       const_cast<Triangulation<2> &>(this->get_tria()).load_user_flags (user_flags);
     }
 
-  for (std::vector<unsigned int>::iterator i=mg_levels[level]->dof_object.dofs.begin();
+  for (std::vector<types::global_dof_index>::iterator i=mg_levels[level]->dof_object.dofs.begin();
        i!=mg_levels[level]->dof_object.dofs.end(); ++i)
     {
       if (*i != DoFHandler<2>::invalid_dof_index)
@@ -1436,7 +1436,7 @@ void DoFHandler<3>::renumber_dofs (const unsigned int  level,
     }
 
   //HEX DoFs
-  for (std::vector<unsigned int>::iterator i=mg_levels[level]->dof_object.dofs.begin();
+  for (std::vector<types::global_dof_index>::iterator i=mg_levels[level]->dof_object.dofs.begin();
        i!=mg_levels[level]->dof_object.dofs.end(); ++i)
     {
       if (*i != DoFHandler<3>::invalid_dof_index)
@@ -1574,13 +1574,13 @@ void DoFHandler<dim, spacedim>::MGVertexDoFs::init (const unsigned int cl, const
   const unsigned int n_levels = finest_level - coarsest_level + 1;
   const unsigned int n_indices = n_levels * dofs_per_vertex;
 
-  indices = new unsigned int[n_indices];
+  indices = new types::global_dof_index[n_indices];
   Assert (indices != 0, ExcNoMemory ());
 
   for (unsigned int i = 0; i < n_indices; ++i)
     indices[i] = DoFHandler<dim, spacedim>::invalid_dof_index;
 
-  indices_offset = new unsigned int[n_levels];
+  indices_offset = new types::global_dof_index[n_levels];
   Assert (indices != 0, ExcNoMemory ());
 
   for (unsigned int i = 0; i < n_levels; ++i)
index 80634abba3d1507a7cbda48b682a5c44a4893d51..9f9ccbf7ba4c489459dfb29d79932dc20a516ce7 100644 (file)
@@ -33,7 +33,7 @@ for (deal_II_dimension : DIMENSIONS)
     template class DoFHandler<1,deal_II_dimension>;
     
     template
-    unsigned int
+    types::global_dof_index
     DoFHandler<1,3>::
     get_dof_index<1> (const unsigned int       obj_level,
                              const unsigned int       obj_index,
@@ -42,7 +42,7 @@ for (deal_II_dimension : DIMENSIONS)
 #endif
 
 template
-unsigned int
+types::global_dof_index
 DoFHandler<deal_II_dimension,deal_II_dimension>::
 get_dof_index<1> (const unsigned int       obj_level,
                  const unsigned int       obj_index,
@@ -51,7 +51,7 @@ get_dof_index<1> (const unsigned int       obj_level,
 
 #if deal_II_dimension < 3
 template
-unsigned int
+types::global_dof_index
 DoFHandler<deal_II_dimension,deal_II_dimension+1>::
 get_dof_index<1> (const unsigned int       obj_level,
                  const unsigned int       obj_index,
@@ -61,7 +61,7 @@ get_dof_index<1> (const unsigned int       obj_level,
 
 #if deal_II_dimension >= 2
 template
-unsigned int
+types::global_dof_index
 DoFHandler<deal_II_dimension,deal_II_dimension>::
 get_dof_index<2> (const unsigned int       obj_level,
                  const unsigned int       obj_index,
@@ -70,7 +70,7 @@ get_dof_index<2> (const unsigned int       obj_level,
 
 #if deal_II_dimension < 3
 template
-unsigned int
+types::global_dof_index
 DoFHandler<deal_II_dimension,deal_II_dimension+1>::
 get_dof_index<2> (const unsigned int       obj_level,
                  const unsigned int       obj_index,
@@ -80,7 +80,7 @@ get_dof_index<2> (const unsigned int       obj_level,
 
 #if deal_II_dimension >= 3
 template
-unsigned int
+types::global_dof_index
 DoFHandler<deal_II_dimension,deal_II_dimension>::
 get_dof_index<3> (const unsigned int       obj_level,
                  const unsigned int       obj_index,
@@ -93,20 +93,20 @@ template
 void
 DoFHandler<deal_II_dimension,deal_II_dimension>::
 set_dof_index<1> (const unsigned int       obj_level,
-                 const unsigned int       obj_index,
-                 const unsigned int       fe_index,
-                 const unsigned int       local_index,
-                 const unsigned int       global_index) const;
+                 const unsigned int            obj_index,
+                 const unsigned int            fe_index,
+                 const unsigned int            local_index,
+                 const types::global_dof_index global_index) const;
 
 #if deal_II_dimension < 3
 template
 void
 DoFHandler<deal_II_dimension,deal_II_dimension+1>::
 set_dof_index<1> (const unsigned int       obj_level,
-                 const unsigned int       obj_index,
-                 const unsigned int       fe_index,
-                 const unsigned int       local_index,
-                 const unsigned int       global_index) const;
+                 const unsigned int            obj_index,
+                 const unsigned int            fe_index,
+                 const unsigned int            local_index,
+                 const types::global_dof_index global_index) const;
 #endif
 
 #if deal_II_dimension < 2
@@ -114,10 +114,10 @@ template
 void
 DoFHandler<deal_II_dimension,deal_II_dimension+2>::
 set_dof_index<1> (const unsigned int       obj_level,
-                 const unsigned int       obj_index,
-                 const unsigned int       fe_index,
-                 const unsigned int       local_index,
-                 const unsigned int       global_index) const;
+                 const unsigned int            obj_index,
+                 const unsigned int            fe_index,
+                 const unsigned int            local_index,
+                 const types::global_dof_index global_index) const;
 #endif
 
 #if deal_II_dimension >= 2
@@ -125,20 +125,20 @@ template
 void
 DoFHandler<deal_II_dimension,deal_II_dimension>::
 set_dof_index<2> (const unsigned int       obj_level,
-                 const unsigned int       obj_index,
-                 const unsigned int       fe_index,
-                 const unsigned int       local_index,
-                 const unsigned int       global_index) const;
+                 const unsigned int            obj_index,
+                 const unsigned int            fe_index,
+                 const unsigned int            local_index,
+                 const types::global_dof_index global_index) const;
 
 #if deal_II_dimension < 3
 template
 void
 DoFHandler<deal_II_dimension,deal_II_dimension+1>::
 set_dof_index<2> (const unsigned int       obj_level,
-                 const unsigned int       obj_index,
-                 const unsigned int       fe_index,
-                 const unsigned int       local_index,
-                 const unsigned int       global_index) const;
+                 const unsigned int            obj_index,
+                 const unsigned int            fe_index,
+                 const unsigned int            local_index,
+                 const types::global_dof_index global_index) const;
 #endif
 
 #if deal_II_dimension >= 3
@@ -146,10 +146,10 @@ template
 void
 DoFHandler<deal_II_dimension,deal_II_dimension>::
 set_dof_index<3> (const unsigned int       obj_level,
-                 const unsigned int       obj_index,
-                 const unsigned int       fe_index,
-                 const unsigned int       local_index,
-                 const unsigned int       global_index) const;
+                 const unsigned int            obj_index,
+                 const unsigned int            fe_index,
+                 const unsigned int            local_index,
+                 const types::global_dof_index global_index) const;
 #endif
 #endif
   }
index 9335c160ad02dc7ef814cefcebd020005f9ce1d5..08e28bcc33fda6a5c6ec52e038e749099f83587a 100644 (file)
@@ -54,14 +54,14 @@ for (deal_II_dimension, structdim : DIMENSIONS)
                   const unsigned int       obj_index,
                   const unsigned int       fe_index,
                   const unsigned int       local_index,
-                  const unsigned int       global_index);
+                  const types::global_dof_index global_index);
 #endif
 
 
 #if (deal_II_dimension == 3) && (structdim < 3)
 
     template
-    unsigned int
+    types::global_dof_index
     DoFObjects<structdim>::
     get_dof_index (const dealii::DoFHandler<1,3> &dof_handler,
                   const unsigned int       obj_index,
index e0a5e64a34287fc7812c4f1221e247d5d00e0b0d..bdcccec352656c56f7c82cca9b71d6883b309eae 100644 (file)
@@ -5131,8 +5131,8 @@ namespace DoFTools
     // innocent block of code. basically, it must be the
     // ConstraintMatrix::add_entry call which takes the bulk of the time,
     // but it is not known to the author how to make it faster...
-    std::vector<std::pair<unsigned int,double> > constraint_line;
-    for (unsigned int global_dof=0; global_dof<n_fine_dofs; ++global_dof)
+    std::vector<std::pair<types::global_dof_index,double> > constraint_line;
+    for (types::global_dof_index global_dof=0; global_dof<n_fine_dofs; ++global_dof)
       if (weight_mapping[global_dof] != -1)
         // this global dof is a parameter dof, so it may carry a constraint
         // note that for each global dof, the sum of weights shall be one,
@@ -5178,8 +5178,8 @@ namespace DoFTools
               const std::map<unsigned int,float>::const_iterator
               j = weights[row].find(col);
               if ((j != weights[row].end()) && (j->second != 0))
-                constraint_line.push_back (std::pair<unsigned int,double>(representants[row],
-                                                                          j->second));
+                constraint_line.push_back (std::pair<types::global_dof_index,double>(representants[row],
+                                                                                     j->second));
             };
 
           constraints.add_entries (global_dof, constraint_line);
index 111b81394a62cc4a6ba4e211c9da9e540ad503e5..fb01f675dc7fc943a9bdb767431422c9107ca5a6 100644 (file)
@@ -136,10 +136,10 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi
       (const VEC&, std::vector<float>&) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
@@ -150,20 +150,20 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<double> > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<float> > &) const;
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<double> > >, bool) const;
 //     template
 //       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
-//       (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+//       (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
 //        VectorSlice<std::vector<std::vector<float> > >, bool) const;
 
     template
@@ -171,7 +171,7 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi
       (const VEC&, std::vector<Tensor<1,deal_II_space_dimension> > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_gradients<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Tensor<1,deal_II_space_dimension> > &) const;
 
     template
@@ -179,7 +179,7 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi
       (const VEC&, std::vector<std::vector<Tensor<1,deal_II_space_dimension> > > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_gradients<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<Tensor<1,deal_II_space_dimension> > > >, bool) const;
 
     template
@@ -187,7 +187,7 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi
       (const VEC&, std::vector<Tensor<2,deal_II_space_dimension> > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_hessians<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Tensor<2,deal_II_space_dimension> > &) const;
 
     template
@@ -195,7 +195,7 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi
       (const VEC&, std::vector<std::vector<Tensor<2,deal_II_space_dimension> > > &, bool) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_hessians<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<Tensor<2,deal_II_space_dimension> > > >, bool) const;
 
     template
@@ -206,10 +206,10 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi
       (const VEC&, std::vector<float>&) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
@@ -220,20 +220,20 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<double> > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<float> > &) const;
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<std::vector<double> > &, bool) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
-      (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<std::vector<float> > &, bool) const;
 
 #endif
@@ -360,10 +360,10 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<float>&) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
 
     template
       void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
@@ -374,20 +374,20 @@ for (deal_II_dimension : DIMENSIONS)
 
     template
       void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<double> > &) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<float> > &) const;
 
     template
       void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<double> > >, bool) const;
 //     template
 //       void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
-//       (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+//       (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
 //        VectorSlice<std::vector<std::vector<float> > >, bool) const;
 
     template
@@ -395,7 +395,7 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<Tensor<1,deal_II_dimension> > &) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_gradients<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Tensor<1,deal_II_dimension> > &) const;
 
     template
@@ -403,7 +403,7 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<std::vector<Tensor<1,deal_II_dimension> > > &) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_gradients<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<Tensor<1,deal_II_dimension> > > >, bool) const;
 
     template
@@ -411,7 +411,7 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<Tensor<2,deal_II_dimension> > &) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_hessians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Tensor<2,deal_II_dimension> > &) const;
 
     template
@@ -419,7 +419,7 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<std::vector<Tensor<2,deal_II_dimension> > > &, bool) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_hessians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<Tensor<2,deal_II_dimension> > > >, bool) const;
 
     template
@@ -430,10 +430,10 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<float>&) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
 
     template
       void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
@@ -444,20 +444,20 @@ for (deal_II_dimension : DIMENSIONS)
 
     template
       void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<double> > &) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<float> > &) const;
 
     template
       void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<std::vector<double> > &, bool) const;
     template
       void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<std::vector<float> > &, bool) const;
 
 
@@ -471,10 +471,10 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<float>&) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
@@ -485,20 +485,20 @@ for (deal_II_dimension : DIMENSIONS)
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<double> > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<float> > &) const;
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<double> > >, bool) const;
 //     template
 //       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
-//       (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+//       (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
 //        VectorSlice<std::vector<std::vector<float> > >, bool) const;
 
     template
@@ -506,7 +506,7 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<Tensor<1,deal_II_dimension+1> > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_gradients<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Tensor<1,deal_II_dimension+1> > &) const;
 
     template
@@ -514,7 +514,7 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<std::vector<Tensor<1,deal_II_dimension+1> > > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_gradients<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<Tensor<1,deal_II_dimension+1> > > >, bool) const;
 
     template
@@ -522,7 +522,7 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<Tensor<2,deal_II_dimension+1> > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_hessians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Tensor<2,deal_II_dimension+1> > &) const;
 
     template
@@ -530,7 +530,7 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<std::vector<Tensor<2,deal_II_dimension+1> > > &, bool) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_hessians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        VectorSlice<std::vector<std::vector<Tensor<2,deal_II_dimension+1> > > >, bool) const;
 
     template
@@ -541,10 +541,10 @@ for (deal_II_dimension : DIMENSIONS)
       (const IndexSet&, std::vector<float>&) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
@@ -555,20 +555,20 @@ for (deal_II_dimension : DIMENSIONS)
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<double> > &) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<Vector<float> > &) const;
 
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<std::vector<double> > &, bool) const;
     template
       void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
-      (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+      (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
        std::vector<std::vector<float> > &, bool) const;
 
 #endif
index 3b1b4e6a7466e574ba300bf253b2ecfb5d6690cd..d8a46dcf3f8571fd5d503d693f395a30961385ce 100644 (file)
@@ -81,13 +81,13 @@ for (S1, S2 : REAL_SCALARS)
                const S1) const;
     template void ChunkSparseMatrix<S1>::
       PSOR<S2> (Vector<S2> &,
-               const std::vector<unsigned int>&,
-               const std::vector<unsigned int>&,
+               const std::vector<types::global_dof_index>&,
+               const std::vector<types::global_dof_index>&,
                const S1) const;
     template void ChunkSparseMatrix<S1>::
       TPSOR<S2> (Vector<S2> &,
-                const std::vector<unsigned int>&,
-                const std::vector<unsigned int>&,
+                const std::vector<types::global_dof_index>&,
+                const std::vector<types::global_dof_index>&,
                 const S1) const;
     template void ChunkSparseMatrix<S1>::
       SOR_step<S2> (Vector<S2> &,
@@ -188,13 +188,13 @@ for (S1, S2, S3 : REAL_SCALARS;
 //             const S1) const;
 //     template void ChunkSparseMatrix<S1>::
 //       PSOR<S2> (Vector<S2> &,
-//             const std::vector<unsigned int>&,
-//             const std::vector<unsigned int>&,
+//             const std::vector<types::global_dof_index>&,
+//             const std::vector<types::global_dof_index>&,
 //             const S1) const;
 //     template void ChunkSparseMatrix<S1>::
 //       TPSOR<S2> (Vector<S2> &,
-//              const std::vector<unsigned int>&,
-//              const std::vector<unsigned int>&,
+//              const std::vector<types::global_dof_index>&,
+//              const std::vector<types::global_dof_index>&,
 //              const S1) const;
 //     template void ChunkSparseMatrix<S1>::
 //       SOR_step<S2> (Vector<S2> &,
index 273f3bf726901d1985c26b780e8ee718e9dd6ad0..f589438965f1031bdcedf250ea59202b8433a805 100644 (file)
@@ -151,7 +151,7 @@ CompressedSparsityPattern::Line::flush_cache () const
               ExcInternalError());
       if (n_new_entries > entries.size())
         {
-          std::vector<unsigned int> new_entries;
+          std::vector<types::global_dof_index> new_entries;
           new_entries.reserve (n_new_entries);
           unsigned int cache_position = 0;
           unsigned int entry_position = 0;
@@ -265,7 +265,7 @@ CompressedSparsityPattern::Line::add_entries (ForwardIterator begin,
                   ExcInternalError());
           if (n_new_entries > entries.size())
             {
-              std::vector<unsigned int> new_entries;
+              std::vector<types::global_dof_index> new_entries;
               new_entries.reserve (n_new_entries);
               ForwardIterator my_it = begin;
               unsigned int entry_position = 0;
index 7e47773f01a584e86b03563470bd034cf37def4e..b4cc95432b18357efa22d69f1d3d0899e30f9318 100644 (file)
@@ -20,7 +20,7 @@ my $vector_functions = <<'EOT'
 template void ConstraintMatrix::condense<V1 >(const V1 &, V1&) const;
 template void ConstraintMatrix::condense<V1 >(V1 &vec) const;
 template void ConstraintMatrix::distribute_local_to_global<V1 > (
-    const Vector<double>&, const std::vector<unsigned int> &, V1&, const FullMatrix<double>&) const;
+    const Vector<double>&, const std::vector<types::global_dof_index> &, V1&, const FullMatrix<double>&) const;
 template void ConstraintMatrix::distribute<V1 >(const V1 &, V1&) const;
 template void ConstraintMatrix::distribute<V1 >(V1 &) const;
 EOT
index 47db43ec24581b7727df922158f26da399ac1af8..0a08486187d81fb7a6a48b14cf61cb0a32ee44bf 100644 (file)
@@ -22,22 +22,22 @@ for (S : REAL_SCALARS)
       std::ostream&, const unsigned int, const unsigned int) const;    
 
     template void FullMatrix<S>::copy_from<1>(
-      const Tensor<2,1>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned);
+      const Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type);
 
     template void FullMatrix<S>::copy_from<2>(
-      const Tensor<2,2>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned);
+      const Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type);
 
     template void FullMatrix<S>::copy_from<3>(
-      const Tensor<2,3>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned);
+      const Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type);
 
     template void FullMatrix<S>::copy_to<1>(
-      Tensor<2,1>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const;
+      Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const;
 
     template void FullMatrix<S>::copy_to<2>(
-      Tensor<2,2>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const;
+      Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const;
 
     template void FullMatrix<S>::copy_to<3>(
-      Tensor<2,3>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const;
+      Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const;
   }
 
 for (S1, S2 : REAL_SCALARS)
index c585b15296b15c9ddcdd29ff2c53ea99a8a8a77c..d150412cd1f9cf67929201b15d76fdbe4a317bd4 100644 (file)
@@ -1409,8 +1409,8 @@ SparseDirectMA47::fill_A (const SparseMatrix<double> &matrix)
 
 
 void
-SparseDirectMA47::call_ma47id (double       *CNTL,   // length 2
-                               unsigned int *ICNTL)  // length 7
+SparseDirectMA47::call_ma47id (double    *CNTL,   // length 2
+                               size_type *ICNTL)  // length 7
 {
   HSL::MA47::ma47id_ (CNTL, ICNTL);
 }
index ad686e7118259533ad401b615e9cb5d8f0b5acde..26432a78a26e63241b27b026f93bd4e464465786 100644 (file)
@@ -85,7 +85,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
        SparseMatrix<double>      &matrix,
        const FunctionMap<deal_II_space_dimension>::type &rhs,
        Vector<double>            &rhs_vector,
-       std::vector<unsigned int> &dof_to_boundary_mapping,
+       std::vector<types::global_dof_index> &dof_to_boundary_mapping,
        const Function<deal_II_space_dimension> * const a,
        std::vector<unsigned int>);
 
@@ -97,7 +97,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
        SparseMatrix<double>      &matrix,
        const FunctionMap<deal_II_space_dimension>::type &rhs,
        Vector<double>            &rhs_vector,
-       std::vector<unsigned int> &dof_to_boundary_mapping,
+       std::vector<types::global_dof_index> &dof_to_boundary_mapping,
        const Function<deal_II_space_dimension> * const a,
        std::vector<unsigned int>);
 
@@ -192,7 +192,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
        SparseMatrix<double>&,
        const FunctionMap<deal_II_dimension>::type&,
        Vector<double>&,
-       std::vector<unsigned int>&,
+       std::vector<types::global_dof_index>&,
        const Function<deal_II_dimension> * const,
        std::vector<unsigned int>);
 
@@ -203,7 +203,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
        SparseMatrix<double>&,
        const FunctionMap<deal_II_dimension>::type&,
        Vector<double>&,
-       std::vector<unsigned int>&,
+       std::vector<types::global_dof_index>&,
        const Function<deal_II_dimension> * const,
        std::vector<unsigned int>);
 
index 14aed16b6760ae2d504dd78cd8e4d7405c7f3677..c2d78805f1f6152589b27f50c3116ae69b70ce97 100644 (file)
@@ -76,7 +76,7 @@ void SolutionTransfer<dim, VECTOR, DH>::prepare_for_pure_refinement()
   n_dofs_old=dof_handler->n_dofs();
 
   // efficient reallocation of indices_on_cell
-  std::vector<std::vector<unsigned int> > (n_active_cells)
+  std::vector<std::vector<types::global_dof_index> > (n_active_cells)
   .swap(indices_on_cell);
 
   typename DH::active_cell_iterator cell = dof_handler->begin_active(),
@@ -291,7 +291,7 @@ prepare_for_coarsening_and_refinement(const std::vector<VECTOR> &all_in)
   // allocate the needed memory. initialize
   // the following arrays in an efficient
   // way, without copying much
-  std::vector<std::vector<unsigned int> >
+  std::vector<std::vector<types::global_dof_index> >
   (n_cells_to_stay_or_refine)
   .swap(indices_on_cell);
 
@@ -516,7 +516,7 @@ interpolate (const std::vector<VECTOR> &all_in,
 
       if (pointerstruct!=cell_map_end)
         {
-          const std::vector<unsigned int> *const indexptr
+          const std::vector<types::global_dof_index> *const indexptr
             =pointerstruct->second.indices_ptr;
 
           const std::vector<Vector<typename VECTOR::value_type> > *const valuesptr
index eedd5c9de32cc4fd4b9049df57ad50371b95f7a0..91061586fba95681803a166dcafa65ffa09f9bc0 100644 (file)
@@ -284,7 +284,7 @@ for (deal_II_dimension : DIMENSIONS)
           const MGDoFHandler<deal_II_dimension> &,
           const types::boundary_id,
           const Function<deal_II_dimension>   &,
-          std::map<unsigned int,double>       &,
+          std::map<types::global_dof_index,double>       &,
           const ComponentMask    &);
     \}
 }
@@ -299,7 +299,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
         (const Mapping<deal_II_dimension,deal_II_space_dimension>    &,
          const DH<deal_II_dimension,deal_II_space_dimension> &,
          const FunctionMap<deal_II_space_dimension>::type &,
-         std::map<unsigned int,double>       &,
+         std::map<types::global_dof_index,double>       &,
          const ComponentMask    &);
 
       template
@@ -308,7 +308,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
          const DH<deal_II_dimension,deal_II_space_dimension> &,
          const types::boundary_id,
          const Function<deal_II_space_dimension>   &,
-         std::map<unsigned int,double>       &,
+         std::map<types::global_dof_index,double>       &,
          const ComponentMask    &);
 
       template
@@ -316,14 +316,14 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
           const DH<deal_II_dimension,deal_II_space_dimension> &,
           const types::boundary_id,
           const Function<deal_II_space_dimension>   &,
-          std::map<unsigned int,double>       &,
+          std::map<types::global_dof_index,double>       &,
           const ComponentMask    &);
 
       template
         void interpolate_boundary_values
         (const DH<deal_II_dimension,deal_II_space_dimension> &,
          const FunctionMap<deal_II_space_dimension>::type &,
-         std::map<unsigned int,double>       &,
+         std::map<types::global_dof_index,double>       &,
          const ComponentMask    &);
 
       template
@@ -511,7 +511,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
          const DoFHandler<deal_II_dimension>  &,
          const FunctionMap<deal_II_dimension>::type &,
          const Quadrature<deal_II_dimension-1>&,
-         std::map<unsigned int,double>&, std::vector<unsigned int>);
+         std::map<types::global_dof_index,double>&, std::vector<unsigned int>);
 #endif
 
       template
@@ -519,7 +519,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
         (const DoFHandler<deal_II_dimension>  &,
          const FunctionMap<deal_II_dimension>::type &,
          const Quadrature<deal_II_dimension-1>&,
-         std::map<unsigned int,double>&, std::vector<unsigned int>);
+         std::map<types::global_dof_index,double>&, std::vector<unsigned int>);
 
 
       template

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.