]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Compile using unsigned long long int for global_dof_index but still a lot of warnings...
authorturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 2 Mar 2013 23:23:07 +0000 (23:23 +0000)
committerturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 2 Mar 2013 23:23:07 +0000 (23:23 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28712 0785d39b-7218-0410-832d-ea1e28bc413d

30 files changed:
deal.II/include/deal.II/base/utilities.h
deal.II/include/deal.II/dofs/dof_renumbering.h
deal.II/include/deal.II/dofs/dof_tools.h
deal.II/include/deal.II/grid/grid_generator.h
deal.II/include/deal.II/hp/dof_handler.h
deal.II/include/deal.II/lac/sparse_direct.h
deal.II/include/deal.II/lac/sparse_vanka.templates.h
deal.II/include/deal.II/lac/vector.templates.h
deal.II/include/deal.II/multigrid/mg_tools.h
deal.II/include/deal.II/multigrid/mg_transfer.templates.h
deal.II/include/deal.II/multigrid/mg_transfer_block.h
deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h
deal.II/source/base/utilities.cc
deal.II/source/dofs/dof_renumbering.cc
deal.II/source/dofs/dof_renumbering.inst.in
deal.II/source/dofs/dof_tools.cc
deal.II/source/dofs/dof_tools.inst.in
deal.II/source/grid/grid_generator.cc
deal.II/source/grid/grid_generator.inst.in
deal.II/source/grid/grid_tools.cc
deal.II/source/grid/grid_tools.inst.in
deal.II/source/hp/dof_handler.cc
deal.II/source/hp/dof_handler.inst.in
deal.II/source/lac/full_matrix.inst.in
deal.II/source/lac/sparse_direct.cc
deal.II/source/lac/sparse_matrix.inst.in
deal.II/source/lac/sparsity_pattern.cc
deal.II/source/multigrid/mg_tools.cc
deal.II/source/multigrid/mg_tools.inst.in
deal.II/source/multigrid/mg_transfer_component.inst.in

index 8eb09f00bfc9a9128f940797f406b00d6812cf74..292b9c22f9f3b77c444f5827c5c8c932cd89dcd1 100644 (file)
@@ -324,6 +324,27 @@ namespace Utilities
   std::vector<unsigned int>
   invert_permutation (const std::vector<unsigned int> &permutation);
 
+  /**
+   * Given a permutation vector (i.e. a
+   * vector $p_0\ldots p_{N-1}$ where each
+   * $p_i\in [0,N)$ and $p_i\neq p_j$ for
+   * $i\neq j$), produce the reverse
+   * permutation $q_i=N-1-p_i$.
+   */
+  std::vector<unsigned long long int>
+  reverse_permutation (const std::vector<unsigned long long int> &permutation);
+
+  /**
+   * Given a permutation vector (i.e. a
+   * vector $p_0\ldots p_{N-1}$ where each
+   * $p_i\in [0,N)$ and $p_i\neq p_j$ for
+   * $i\neq j$), produce the inverse
+   * permutation $q_0\ldots q_{N-1}$ so that
+   * $q_{p_i}=p_{q_i}=i$.
+   */
+  std::vector<unsigned long long int>
+  invert_permutation (const std::vector<unsigned long long int> &permutation);
+
   /**
    * A namespace for utility functions that
    * probe system properties.
index 9ed959c4543b4d920dd31ea508b8ef02551f13cd..f14d277bb2ebab32cacbb449a5c6217ea9b062e7 100644 (file)
@@ -920,7 +920,7 @@ namespace DoFRenumbering
    */
   template <int dim, int spacedim, class ITERATOR, class ENDITERATOR>
   unsigned int
-  compute_block_wise (std::vector<unsigned int> &new_dof_indices,
+  compute_block_wise (std::vector<types::global_dof_index> &new_dof_indices,
                       const ITERATOR &start,
                       const ENDITERATOR &end);
 
index cf6ee8659b9a469309e9eb6f04050ccfca1b1cfc..37418c2e5d544977c666b804531480bd4df7daa1 100644 (file)
@@ -1919,7 +1919,7 @@ namespace DoFTools
                          const DH &dof_handler,
                          const unsigned int level,
                          const std::vector<bool> &selected_dofs = std::vector<bool>(),
-                         unsigned int offset = 0);
+                         types::global_dof_index offset = 0);
 
   /**
    * Create an incidence matrix that
@@ -2297,8 +2297,8 @@ namespace DoFTools
   void
   count_dofs_per_block (const DH &dof,
                         std::vector<types::global_dof_index> &dofs_per_block,
-                        const std::vector<types::global_dof_index>  &target_block
-                        = std::vector<types::global_dof_index>());
+                        const std::vector<unsigned int>  &target_block
+                        = std::vector<unsigned int>());
 
   /**
    * @deprecated See the previous
@@ -2697,7 +2697,7 @@ namespace DoFTools
   void
   map_dofs_to_support_points (const Mapping<dim,spacedim>       &mapping,
                               const DoFHandler<dim,spacedim>    &dof_handler,
-                              std::map<unsigned int, Point<spacedim> >     &support_points);
+                              std::map<types::global_dof_index, Point<spacedim> >     &support_points);
 
   /**
    * Same as the previous function but for the hp case.
@@ -2706,7 +2706,7 @@ namespace DoFTools
   void
   map_dofs_to_support_points (const dealii::hp::MappingCollection<dim,spacedim>   &mapping,
                               const hp::DoFHandler<dim,spacedim>    &dof_handler,
-                              std::map<unsigned int, Point<spacedim> > &support_points);
+                              std::map<types::global_dof_index, Point<spacedim> > &support_points);
 
 
   /**
index 455129df0b2b9393aefe471f440a650839a783bc..054d3c673599793aadac911b427a321a792f1756 100644 (file)
@@ -622,7 +622,7 @@ public:
                                                 const double inner_radius = .25,
                                                 const double outer_radius = .5,
                                                 const double L = .5,
-                                                const unsigned int repetition = 1,
+                                                const size_type repetition = 1,
                                                 const bool colorize = false);
 
   /**
index 751da3e0c472fcb0bc29269a64ce9b248c2a7cbd..1581eeddd405f6b89ec8ba029c06df6af9b7bd99 100644 (file)
@@ -395,7 +395,7 @@ namespace hp
      * Return the number of degrees of freedom
      * located on the boundary.
      */
-    unsigned int n_boundary_dofs () const;
+    types::global_dof_index n_boundary_dofs () const;
 
     /**
      * Return the number of degrees
index 5149d54f5a79b17c19671c79fec76ff4f44a051c..bd21d92236159c7fbf6b1b7d1d1fd782f38e92d1 100644 (file)
@@ -911,8 +911,8 @@ private:
   /**
    * Control values set by <tt>MA47ID</tt>.
    */
-  double    CNTL[2];
-  size_type ICNTL[7];
+  double       CNTL[2];
+  unsigned int ICNTL[7];
 
   /**
    * Info field filled by the MA47
@@ -971,8 +971,8 @@ private:
    * Call the <tt>ma47id</tt> function
    * with the given args.
    */
-  void call_ma47id (double    *CNTL,
-                    size_type *ICNTL);
+  void call_ma47id (double       *CNTL,
+                    unsigned int *ICNTL);
 
   /**
    * Call the <tt>ma47ad</tt> function
@@ -992,31 +992,31 @@ private:
    * Call the <tt>ma47bd</tt> function
    * with the given args.
    */
-  void call_ma47bd (const size_type *n_rows,
-                    const size_type *n_nonzero_elements,
-                    const size_type *column_numbers,
-                    double          *A,
-                    const size_type *LA,
-                    size_type       *IW,
-                    const size_type *LIW,
-                    const size_type *KEEP,
-                    const double    *CNTL,
-                    const size_type *ICNTL,
-                    size_type       *IW1,
-                    int             *INFO);
+  void call_ma47bd (const size_type    *n_rows,
+                    const size_type    *n_nonzero_elements,
+                    const size_type    *column_numbers,
+                    double             *A,
+                    const size_type    *LA,
+                    size_type          *IW,
+                    const size_type    *LIW,
+                    const size_type    *KEEP,
+                    const double       *CNTL,
+                    const unsigned int *ICNTL,
+                    size_type          *IW1,
+                    int                *INFO);
 
   /**
    * Call the <tt>ma47bd</tt> function
    * with the given args.
    */
-  void call_ma47cd (const size_type *n_rows,
-                    const double    *A,
-                    const size_type *LA,
-                    const size_type *IW,
-                    const size_type *LIW,
-                    double          *rhs_and_solution,
-                    size_type       *IW1,
-                    const size_type *ICNTL);
+  void call_ma47cd (const size_type    *n_rows,
+                    const double       *A,
+                    const size_type    *LA,
+                    const size_type    *IW,
+                    const size_type    *LIW,
+                    double             *rhs_and_solution,
+                    size_type          *IW1,
+                    const unsigned int *ICNTL);
 };
 
 
index 519cfceabb9a812d00364f35f1016dc0ae7222a1..af510e256a9fd7f5a0fda79d56514cabd13d337c 100644 (file)
@@ -70,7 +70,8 @@ SparseVanka<number>::compute_inverses ()
                                                selected.end(),
                                                true);
 
-      const size_type n_inverses_per_thread = std::max(n_inverses / n_threads, 1U);
+      const size_type n_inverses_per_thread = std::max(n_inverses / n_threads, 
+          static_cast<size_type> (1U));
 
       // set up start and end index
       // for each of the
@@ -391,7 +392,8 @@ SparseBlockVanka<number>::compute_dof_masks (const SparseMatrix<number> &M,
                                            selected.end(),
                                            true);
 
-  const size_type n_inverses_per_block = std::max(n_inverses / n_blocks, 1U);
+  const size_type n_inverses_per_block = std::max(n_inverses / n_blocks, 
+      static_cast<size_type> (1U));
 
   // precompute the splitting points
   std::vector<std::pair<size_type, size_type> > intervals (n_blocks);
index 03234afcc0175f1731c2a58f62e6e690fd19c31c..99b17993c10f022ee7c704e9a97b63b354b27da3 100644 (file)
@@ -1383,7 +1383,11 @@ void Vector<Number>::block_write (std::ostream &out) const
   const size_type sz = size();
   char buf[16];
 
-  std::sprintf(buf, "%d", sz);
+#ifdef DEAL_II_USE_LARGE_INDEX_TYPE
+  std::sprintf(buf, "%llu", sz);
+#else
+  std::sprintf(buf, "%u", sz);
+#endif
   std::strcat(buf, "\n[");
 
   out.write(buf, std::strlen(buf));
index 532d90a4196a7374dae28b3358e38558f25994ea..90f3aa482c7fa46973a10f1d7f984dd49683bd0c 100644 (file)
@@ -177,7 +177,7 @@ namespace MGTools
   void
   count_dofs_per_block (const DH     &dof_handler,
                         std::vector<std::vector<types::global_dof_index> > &dofs_per_block,
-                        std::vector<types::global_dof_index>  target_block = std::vector<types::global_dof_index>());
+                        std::vector<unsigned int>  target_block = std::vector<unsigned int>());
 
   /**
    * Count the dofs component-wise
index c02da23a5bd9fe0ff15945a70425f49e538dfe33..57a75435e9dbf113449641f1cc4a41b34d8a0ee0 100644 (file)
@@ -69,7 +69,7 @@ namespace
   template <int dim, typename number, int spacedim>
   void
   reinit_vector (const dealii::DoFHandler<dim,spacedim> &mg_dof,
-                 std::vector<types::global_dof_index> target_component,
+                 std::vector<unsigned int> target_component,
                  MGLevelObject<BlockVector<number> > &v)
   {
     const unsigned int n_blocks = mg_dof.get_fe().n_blocks();
index 19b97e44b7b33309ad749b980b7e00d6a9a79cf2..284081e121dc36765ab970dedaf9ff1bc0c18e73 100644 (file)
@@ -128,13 +128,13 @@ protected:
   /**
    * Start index of each block.
    */
-  std::vector<unsigned int> block_start;
+  std::vector<types::global_dof_index> block_start;
 
   /**
    * Start index of each block on
    * all levels.
    */
-  std::vector<std::vector<unsigned int> > mg_block_start;
+  std::vector<std::vector<types::global_dof_index> > mg_block_start;
 
   /**
    * Call build_matrices()
index 6e55196f1e6af91dc0901b4c8f4247ed0fce1a90..fd260b6e992349ca59e13e933eca1cc86e70f1e2 100644 (file)
@@ -99,7 +99,7 @@ MGTransferSelect<number>::copy_from_mg (
       //the block back to dst.
       const unsigned int n_blocks =
         *std::max_element(target_component.begin(), target_component.end()) + 1;
-      std::vector<unsigned int> dofs_per_block (n_blocks);
+      std::vector<types::global_dof_index> dofs_per_block (n_blocks);
       DoFTools::count_dofs_per_block (mg_dof_handler, dofs_per_block, target_component);
       BlockVector<number> tmp;
       tmp.reinit(n_blocks);
index 954fe4d44843f63b8fa3cd96b57ff84e65f72284..51754749eb324a01c0085738ff2960ad5c9627ee 100644 (file)
@@ -464,6 +464,42 @@ namespace Utilities
     return out;
   }
 
+  std::vector<unsigned long long int>
+  reverse_permutation (const std::vector<unsigned long long int> &permutation)
+  {
+    const unsigned long long int n = permutation.size();
+
+    std::vector<unsigned long long int> out (n);
+    for (unsigned long long int i=0; i<n; ++i)
+      out[i] = n - 1 - permutation[i];
+
+    return out;
+  }
+
+
+
+  std::vector<unsigned long long int>
+  invert_permutation (const std::vector<unsigned long int> &permutation)
+  {
+    const unsigned long long int n = permutation.size();
+
+    std::vector<unsigned long long int> out (n, numbers::invalid_unsigned_int);
+
+    for (unsigned long long int i=0; i<n; ++i)
+      {
+        Assert (permutation[i] < n, ExcIndexRange (permutation[i], 0, n));
+        out[permutation[i]] = i;
+      }
+
+    // check that we have actually reached
+    // all indices
+    for (unsigned long long int i=0; i<n; ++i)
+      Assert (out[i] != numbers::invalid_unsigned_int,
+              ExcMessage ("The given input permutation had duplicate entries!"));
+
+    return out;
+  }
+
 
   template <typename Integer>
   std::vector<Integer>
index 14ffc1614c20f9c984366013f09ab1450077e72b..e0c3402c8e4a4739ade85bc2439afed196e78449 100644 (file)
@@ -773,13 +773,13 @@ namespace DoFRenumbering
     types::global_dof_index next_free_index = 0;
     for (unsigned int component=0; component<fe_collection.n_components(); ++component)
       {
-        const typename std::vector<unsigned int>::const_iterator
+        const typename std::vector<types::global_dof_index>::const_iterator
         begin_of_component = component_to_dof_map[component].begin(),
         end_of_component   = component_to_dof_map[component].end();
 
         next_free_index = shifts[component];
 
-        for (typename std::vector<unsigned int>::const_iterator
+        for (typename std::vector<types::global_dof_index>::const_iterator
              dof_index = begin_of_component;
              dof_index != end_of_component; ++dof_index)
           {
index 51be1bd94d9c309b84a34277e8f98d8083dcd1bc..cfde20f725e5fe495eed1f27906dfd260fc5a894 100644 (file)
@@ -28,16 +28,16 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
          (DoFHandler<deal_II_dimension,deal_II_space_dimension>&,
           const bool,
           const bool,
-          const std::vector<unsigned int>&);
+          const std::vector<types::global_dof_index>&);
 
        template
          void
          compute_Cuthill_McKee<DoFHandler<deal_II_dimension,deal_II_space_dimension> >
-         (std::vector<unsigned int>&,
+         (std::vector<types::global_dof_index>&,
           const DoFHandler<deal_II_dimension,deal_II_space_dimension>&,
           const bool,
           const bool,
-          const std::vector<unsigned int>&);
+          const std::vector<types::global_dof_index>&);
 
        template
          void component_wise<deal_II_dimension,deal_II_space_dimension>
@@ -130,16 +130,16 @@ namespace DoFRenumbering
       (hp::DoFHandler<deal_II_dimension>&,
        const bool,
        const bool,
-       const std::vector<unsigned int>&);
+       const std::vector<types::global_dof_index>&);
 
     template
       void
       compute_Cuthill_McKee<hp::DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,
        const hp::DoFHandler<deal_II_dimension>&,
        const bool,
        const bool,
-       const std::vector<unsigned int>&);
+       const std::vector<types::global_dof_index>&);
 
     template
       void component_wise
@@ -183,7 +183,7 @@ namespace DoFRenumbering
 
     template void
       compute_cell_wise<DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&, std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>&,
        const DoFHandler<deal_II_dimension>&,
        const std::vector<DoFHandler<deal_II_dimension>::active_cell_iterator>&);
 
@@ -194,7 +194,7 @@ namespace DoFRenumbering
 
     template void
       compute_cell_wise<DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&, std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>&,
        const DoFHandler<deal_II_dimension>&, unsigned int,
        const std::vector<DoFHandler<deal_II_dimension>::level_cell_iterator>&);
 
@@ -205,7 +205,7 @@ namespace DoFRenumbering
 
     template void
       compute_downstream<DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,std::vector<types::global_dof_index>&,
        const DoFHandler<deal_II_dimension>&, const Point<deal_II_dimension>&,
        const bool);
 
@@ -217,7 +217,7 @@ namespace DoFRenumbering
     template
       void
       compute_clockwise_dg<DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&, const DoFHandler<deal_II_dimension>&,
+      (std::vector<types::global_dof_index>&, const DoFHandler<deal_II_dimension>&,
        const Point<deal_II_dimension>&, const bool);
 
 // Renumbering for hp::DoFHandler
@@ -229,7 +229,7 @@ namespace DoFRenumbering
 
     template void
       compute_cell_wise<hp::DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&, std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>&,
        const hp::DoFHandler<deal_II_dimension>&,
        const std::vector<hp::DoFHandler<deal_II_dimension>::active_cell_iterator>&);
 
@@ -254,7 +254,7 @@ namespace DoFRenumbering
 
     template void
       compute_downstream<hp::DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,std::vector<types::global_dof_index>&,
        const hp::DoFHandler<deal_II_dimension>&,
        const Point<deal_II_dimension>&,
        const bool);
@@ -268,7 +268,7 @@ namespace DoFRenumbering
     template
       void
       compute_clockwise_dg<hp::DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,
        const hp::DoFHandler<deal_II_dimension>&,
        const Point<deal_II_dimension>&,
        const bool);
@@ -296,7 +296,7 @@ namespace DoFRenumbering
     template
       void
       compute_random<DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,
        const DoFHandler<deal_II_dimension> &);
 
     template
@@ -313,14 +313,14 @@ namespace DoFRenumbering
     template
       void
       compute_sort_selected_dofs_back<DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,
        const DoFHandler<deal_II_dimension> &,
        const std::vector<bool> &);
 
     template
       void
       compute_sort_selected_dofs_back<MGDoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,
        const MGDoFHandler<deal_II_dimension> &,
        const std::vector<bool> &,
        const unsigned int);
@@ -332,7 +332,7 @@ namespace DoFRenumbering
     template
       void
       compute_random<hp::DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,
        const hp::DoFHandler<deal_II_dimension> &);
 
     template
@@ -343,7 +343,7 @@ namespace DoFRenumbering
     template
       void
       compute_sort_selected_dofs_back<hp::DoFHandler<deal_II_dimension> >
-      (std::vector<unsigned int>&,
+      (std::vector<types::global_dof_index>&,
        const hp::DoFHandler<deal_II_dimension> &,
        const std::vector<bool> &);
 
@@ -357,14 +357,14 @@ namespace DoFRenumbering
       (DoFHandler<deal_II_dimension>&,
        const unsigned int,
        const bool,
-       const std::vector<unsigned int>&);
+       const std::vector<types::global_dof_index>&);
 
     template
       void Cuthill_McKee<MGDoFHandler<deal_II_dimension> >
       (MGDoFHandler<deal_II_dimension>&,
        const unsigned int,
        const bool,
-       const std::vector<unsigned int>&);
+       const std::vector<types::global_dof_index>&);
 
     \}  // namespace DoFRenumbering
 #endif
index bdcccec352656c56f7c82cca9b71d6883b309eae..fbbfc216fb188760159023236309de1cb131ce9b 100644 (file)
@@ -3588,7 +3588,7 @@ namespace DoFTools
       local_selected_dofs[i] = component_mask[local_component_asssociation[i]];
 
     // then loop over all cells and do work
-    std::vector<unsigned int> indices(fe.dofs_per_cell);
+    std::vector<types::global_dof_index> indices(fe.dofs_per_cell);
     typename DH::level_cell_iterator c;
     for (c = dof.begin(level) ; c != dof.end(level) ; ++ c)
       {
@@ -4333,9 +4333,9 @@ namespace DoFTools
     void
     resolve_components (const FiniteElement<dim,spacedim> &fe,
                         const std::vector<unsigned char> &dofs_by_component,
-                        const std::vector<unsigned int> &target_component,
+                        const std::vector<types::global_dof_index> &target_component,
                         const bool                        only_once,
-                        std::vector<types::global_dof_index>        &dofs_per_component,
+                        std::vector<types::global_dof_index> &dofs_per_component,
                         unsigned int                     &component)
     {
       for (unsigned int b=0; b<fe.n_base_elements(); ++b)
@@ -4374,9 +4374,9 @@ namespace DoFTools
     void
     resolve_components (const hp::FECollection<dim,spacedim> &fe_collection,
                         const std::vector<unsigned char> &dofs_by_component,
-                        const std::vector<unsigned int> &target_component,
+                        const std::vector<types::global_dof_index> &target_component,
                         const bool                        only_once,
-                        std::vector<types::global_dof_index>        &dofs_per_component,
+                        std::vector<types::global_dof_index> &dofs_per_component,
                         unsigned int                     &component)
     {
       // assert that all elements in the collection have the same structure
@@ -4440,7 +4440,7 @@ namespace DoFTools
     const DH      &dof_handler,
     std::vector<types::global_dof_index> &dofs_per_component,
     bool only_once,
-    std::vector<unsigned int>  target_component)
+    std::vector<types::global_dof_index>  target_component)
   {
     const unsigned int n_components = dof_handler.get_fe().n_components();
 
@@ -4521,9 +4521,9 @@ namespace DoFTools
   void
   count_dofs_per_block (const DH &dof_handler,
                         std::vector<types::global_dof_index> &dofs_per_block,
-                        const std::vector<unsigned int> &target_block_)
+                        const std::vector<types::global_dof_index> &target_block_)
   {
-    std::vector<unsigned int>  target_block = target_block_;
+    std::vector<types::global_dof_index>  target_block = target_block_;
 
     const dealii::hp::FECollection<DH::dimension,DH::space_dimension>
     fe_collection (dof_handler.get_fe());
@@ -4597,7 +4597,7 @@ namespace DoFTools
   void
   count_dofs_per_component (const DoFHandler<dim,spacedim> &dof_handler,
                             std::vector<types::global_dof_index>      &dofs_per_component,
-                            std::vector<unsigned int>       target_component)
+                            std::vector<types::global_dof_index>       target_component)
   {
     count_dofs_per_component (dof_handler, dofs_per_component,
                               false, target_component);
@@ -5233,12 +5233,12 @@ namespace DoFTools
                                            weights, weight_mapping);
 
     // now compute the requested representation
-    const unsigned int n_global_parm_dofs
+    const types::global_dof_index n_global_parm_dofs
       = std::count_if (weight_mapping.begin(), weight_mapping.end(),
                        std::bind2nd (std::not_equal_to<int> (), -1));
 
     // first construct the inverse mapping of weight_mapping
-    std::vector<unsigned int> inverse_weight_mapping (n_global_parm_dofs,
+    std::vector<types::global_dof_index> inverse_weight_mapping (n_global_parm_dofs,
                                                       DoFHandler<dim,spacedim>::invalid_dof_index);
     for (unsigned int i=0; i<weight_mapping.size(); ++i)
       {
@@ -5666,7 +5666,7 @@ namespace DoFTools
   {
     typename DH::level_cell_iterator cell;
     typename DH::level_cell_iterator endc = dof_handler.end(level);
-    std::vector<unsigned int> indices;
+    std::vector<types::global_dof_index> indices;
 
     unsigned int i=0;
     for (cell=dof_handler.begin(level); cell != endc; ++i, ++cell)
@@ -5703,7 +5703,7 @@ namespace DoFTools
     typename DH::level_cell_iterator cell;
     typename DH::level_cell_iterator endc = dof_handler.end(level);
 
-    std::vector<unsigned int> indices;
+    std::vector<types::global_dof_index> indices;
     std::vector<bool> exclude;
 
     for (cell=dof_handler.begin(level); cell != endc; ++cell)
@@ -5750,7 +5750,7 @@ namespace DoFTools
     typename DH::level_cell_iterator pcell = dof_handler.begin(level-1);
     typename DH::level_cell_iterator endc = dof_handler.end(level-1);
 
-    std::vector<unsigned int> indices;
+    std::vector<types::global_dof_index> indices;
     std::vector<bool> exclude;
 
     for (unsigned int block = 0; pcell != endc; ++pcell)
@@ -5824,7 +5824,7 @@ namespace DoFTools
                                              numbers::invalid_unsigned_int);
 
     // Estimate for the number of dofs at this point
-    std::vector<unsigned int> vertex_dof_count(dof_handler.get_tria().n_vertices(), 0);
+    std::vector<types::global_dof_index> vertex_dof_count(dof_handler.get_tria().n_vertices(), 0);
 
     // Identify all vertices active on this level and remember some data
     // about them
@@ -5872,7 +5872,7 @@ namespace DoFTools
     // into the sparsity pattern.
     block_list.reinit(vertex_dof_count.size(), dof_handler.n_dofs(level), vertex_dof_count);
 
-    std::vector<unsigned int> indices;
+    std::vector<types::global_dof_index> indices;
     std::vector<bool> exclude;
 
     for (cell=dof_handler.begin(level); cell != endc; ++cell)
index a18d3cfc7d3b0a0c764a3241c257386afe737d82..d2c6af3fb3db2ea85f3031d15306970297fa1b80 100644 (file)
@@ -100,7 +100,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
     DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<deal_II_dimension>,SP>
     (const hp::DoFHandler<deal_II_dimension>& dof,
      const FunctionMap<deal_II_dimension>::type  &boundary_indicators,
-     const std::vector<unsigned int>  &dof_to_boundary_mapping,
+     const std::vector<types::global_dof_index>  &dof_to_boundary_mapping,
      SP    &sparsity);
 
     template void
@@ -115,11 +115,11 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
 
     template void
       DoFTools::make_cell_patches<DoFHandler<deal_II_dimension>,SP>
-      (SP&, const DoFHandler<deal_II_dimension>&, unsigned int, const std::vector<bool>&, unsigned int);
+      (SP&, const DoFHandler<deal_II_dimension>&, const unsigned int, const std::vector<bool>&, types::global_dof_index);
 
     template void
       DoFTools::make_cell_patches<MGDoFHandler<deal_II_dimension>,SP>
-      (SP&, const MGDoFHandler<deal_II_dimension>&, unsigned int, const std::vector<bool>&, unsigned int);
+      (SP&, const MGDoFHandler<deal_II_dimension>&, const unsigned int, const std::vector<bool>&, types::global_dof_index);
 
 #if deal_II_dimension > 1
 
@@ -203,27 +203,27 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
     template void
     DoFTools::make_boundary_sparsity_pattern<DoFHandler<deal_II_dimension,deal_II_dimension+1>,SP>
     (const DoFHandler<deal_II_dimension,deal_II_dimension+1>& dof,
-     const std::vector<unsigned int>  &,
+     const std::vector<types::global_dof_index>  &,
      SP    &);
 
     //template void
     //DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>,SP>
     //(const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>& dof,
-    // const std::vector<unsigned int>  &,
+    // const std::vector<types::global_dof_index>  &,
     // SP    &);
 
     template void
     DoFTools::make_boundary_sparsity_pattern<DoFHandler<deal_II_dimension,deal_II_dimension+1>,SP>
     (const DoFHandler<deal_II_dimension,deal_II_dimension+1>& dof,
      const FunctionMap<deal_II_dimension+1>::type  &boundary_indicators,
-     const std::vector<unsigned int>  &dof_to_boundary_mapping,
+     const std::vector<types::global_dof_index>  &dof_to_boundary_mapping,
      SP    &sparsity);
 
     //template void
     //DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>,SP>
     //(const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>& dof,
     // const FunctionMap<deal_II_dimension+1>::type  &boundary_indicators,
-    // const std::vector<unsigned int>  &dof_to_boundary_mapping,
+    // const std::vector<types::global_dof_index>  &dof_to_boundary_mapping,
     // SP    &sparsity);
 
 #endif
@@ -280,27 +280,27 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
     template void
     DoFTools::make_boundary_sparsity_pattern<DoFHandler<1,3>,SP>
     (const DoFHandler<1,3>& dof,
-     const std::vector<unsigned int>  &,
+     const std::vector<types::global_dof_index>  &,
      SP    &);
 
     //template void
     //DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<1,3>,SP>
     //(const hp::DoFHandler<1,3>& dof,
-    // const std::vector<unsigned int>  &,
+    // const std::vector<types::global_dof_index>  &,
     // SP    &);
 
     template void
     DoFTools::make_boundary_sparsity_pattern<DoFHandler<1,3>,SP>
     (const DoFHandler<1,3>& dof,
      const FunctionMap<3>::type  &boundary_indicators,
-     const std::vector<unsigned int>  &dof_to_boundary_mapping,
+     const std::vector<types::global_dof_index>  &dof_to_boundary_mapping,
      SP    &sparsity);
 
     //template void
     //DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<1,3>,SP>
     //(const hp::DoFHandler<1,3>& dof,
     // const FunctionMap<3>::type  &boundary_indicators,
-    // const std::vector<unsigned int>  &dof_to_boundary_mapping,
+    // const std::vector<types::global_dof_index>  &dof_to_boundary_mapping,
     // SP    &sparsity);
 
 #endif
@@ -799,13 +799,13 @@ template
 void
 DoFTools::count_dofs_per_component<DoFHandler<deal_II_dimension> > (
   const DoFHandler<deal_II_dimension>&,
-  std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+  std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
 
 template
 void
 DoFTools::count_dofs_per_component<hp::DoFHandler<deal_II_dimension> > (
   const hp::DoFHandler<deal_II_dimension>&,
-  std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+  std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
 
 
 #if deal_II_dimension < 3
@@ -813,13 +813,13 @@ template
 void
 DoFTools::count_dofs_per_component<DoFHandler<deal_II_dimension, deal_II_dimension+1> > (
   const DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
-  std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+  std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
 
 template
 void
 DoFTools::count_dofs_per_component<hp::DoFHandler<deal_II_dimension, deal_II_dimension+1> > (
   const hp::DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
-  std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+  std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
 
 template
 void
@@ -845,13 +845,13 @@ template
 void
 DoFTools::count_dofs_per_component<DoFHandler<1,3> > (
   const DoFHandler<1,3>&,
-  std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+  std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
 
 template
 void
 DoFTools::count_dofs_per_component<hp::DoFHandler<1,3> > (
   const hp::DoFHandler<1,3>&,
-  std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+  std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
 
 template
 void
@@ -876,28 +876,28 @@ template
 void
 DoFTools::count_dofs_per_block<DoFHandler<deal_II_dimension> > (
   const DoFHandler<deal_II_dimension>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::count_dofs_per_block<hp::DoFHandler<deal_II_dimension> > (
   const hp::DoFHandler<deal_II_dimension>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::count_dofs_per_block<MGDoFHandler<deal_II_dimension> > (
   const MGDoFHandler<deal_II_dimension>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::count_dofs_per_component<deal_II_dimension> (
   const DoFHandler<deal_II_dimension>&,
-  std::vector<unsigned int>&, std::vector<unsigned int>);
+  std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>);
 
 template
 void
@@ -921,13 +921,13 @@ void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &,
  const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
 
 
 
@@ -936,13 +936,13 @@ void
 DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &,
  const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
 
 
 
@@ -967,7 +967,7 @@ void
 DoFTools::map_dofs_to_support_points<deal_II_dimension>
 (const Mapping<deal_II_dimension,deal_II_dimension>&,
  const DoFHandler<deal_II_dimension>&,
- std::map<unsigned int, Point<deal_II_dimension> >&);
+ std::map<types::global_dof_index, Point<deal_II_dimension> >&);
 
 
 template
@@ -975,7 +975,7 @@ void
 DoFTools::map_dofs_to_support_points<deal_II_dimension>
 (const hp::MappingCollection<deal_II_dimension,deal_II_dimension>&,
  const hp::DoFHandler<deal_II_dimension>&,
- std::map<unsigned int, Point<deal_II_dimension> >&);
+ std::map<types::global_dof_index, Point<deal_II_dimension> >&);
 
 #if deal_II_dimension < 3
 
@@ -998,36 +998,36 @@ void
 DoFTools::map_dofs_to_support_points<deal_II_dimension,deal_II_dimension+1>
 (const Mapping<deal_II_dimension,deal_II_dimension+1>&,
  const DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
- std::map<unsigned int, Point<deal_II_dimension+1> >&);
+ std::map<types::global_dof_index, Point<deal_II_dimension+1> >&);
 
 template
 void
 DoFTools::map_dofs_to_support_points<deal_II_dimension,deal_II_dimension+1>
 (const hp::MappingCollection<deal_II_dimension,deal_II_dimension+1>&,
  const hp::DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
- std::map<unsigned int, Point<deal_II_dimension+1> >&);
+ std::map<types::global_dof_index, Point<deal_II_dimension+1> >&);
 
 
 template
 void
 DoFTools::count_dofs_per_block<DoFHandler<deal_II_dimension,deal_II_dimension+1> > (
   const DoFHandler<deal_II_dimension,deal_II_dimension+1>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::count_dofs_per_block<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> > (
   const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::count_dofs_per_block<MGDoFHandler<deal_II_dimension,deal_II_dimension+1> > (
   const MGDoFHandler<deal_II_dimension,deal_II_dimension+1>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 #endif
 
@@ -1045,22 +1045,22 @@ template
 void
 DoFTools::count_dofs_per_block<DoFHandler<1,3> > (
   const DoFHandler<1,3>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::count_dofs_per_block<hp::DoFHandler<1,3> > (
   const hp::DoFHandler<1,3>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::count_dofs_per_block<MGDoFHandler<1,3> > (
   const MGDoFHandler<1,3>&,
-  std::vector<unsigned int>&,
-  const std::vector<unsigned int> &);
+  std::vector<types::global_dof_index>&,
+  const std::vector<types::global_dof_index> &);
 
 #endif
 
@@ -1114,13 +1114,13 @@ void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
  const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
 
 
 template
@@ -1134,13 +1134,13 @@ DoFTools::extract_hanging_node_dofs
  DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
  (const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
   const std::set<types::boundary_id> &,
-  std::vector<unsigned int> &);
+  std::vector<types::global_dof_index> &);
 
  template
  void
  DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
  (const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
-  std::vector<unsigned int> &);
+  std::vector<types::global_dof_index> &);
 
 #endif
 
@@ -1151,13 +1151,13 @@ void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<1,3> >
 (const DoFHandler<1,3> &,
  const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
 
 template
 void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<1,3> >
 (const DoFHandler<1,3> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
 
 
 template
@@ -1171,13 +1171,13 @@ DoFTools::extract_hanging_node_dofs
 // DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<1,3> >
 // (const hp::DoFHandler<1,3> &,
 //  const std::set<unsigned char> &,
-//  std::vector<unsigned int> &);
+//  std::vector<types::global_dof_index> &);
 
 // template
 // void
 // DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<1,3> >
 // (const hp::DoFHandler<1,3> &,
-//  std::vector<unsigned int> &);
+//  std::vector<types::global_dof_index> &);
 
 #endif
 
index fa4125060e2b161f94e007eff65ce90221426054..da5e36333fcf2c6cf671fcd343feba3f89f6a16b 100644 (file)
@@ -2808,7 +2808,7 @@ GridGenerator::hyper_shell (Triangulation<3> &tria,
                             const Point<3> &p,
                             const double inner_radius,
                             const double outer_radius,
-                            const unsigned int n,
+                            const size_type n,
                             const bool colorize)
 {
   Assert ((inner_radius > 0) && (inner_radius < outer_radius),
@@ -3037,7 +3037,7 @@ GridGenerator::half_hyper_shell (Triangulation<3> &tria,
                                  const Point<3> &center,
                                  const double inner_radius,
                                  const double outer_radius,
-                                 const unsigned int n,
+                                 const size_type n,
                                  const bool colorize)
 {
   Assert ((inner_radius > 0) && (inner_radius < outer_radius),
@@ -3183,7 +3183,7 @@ void GridGenerator::quarter_hyper_shell (Triangulation<3> &tria,
                                          const Point<3> &center,
                                          const double inner_radius,
                                          const double outer_radius,
-                                         const unsigned int n,
+                                         const size_type n,
                                          const bool colorize)
 {
   Assert ((inner_radius > 0) && (inner_radius < outer_radius),
@@ -3370,7 +3370,7 @@ merge_triangulations (const Triangulation<dim, spacedim> &triangulation_1,
   // throw out duplicated vertices from the two meshes
   // and create the triangulation
   SubCellData subcell_data;
-  std::vector<size_type> considered_vertices;
+  std::vector<unsigned int> considered_vertices;
   GridTools::delete_duplicated_vertices (vertices, cells, subcell_data, considered_vertices);
   result.clear ();
   result.create_triangulation (vertices, cells, subcell_data);
index 5444c06e09c26fd569e239f55a6c874bcc21f370..a579b332176024e532931c8ef6a98f503e900b11 100644 (file)
@@ -73,14 +73,14 @@ for (deal_II_dimension : DIMENSIONS)
     template void
       GridGenerator::subdivided_parallelepiped<deal_II_dimension> (
        Triangulation<deal_II_dimension>&,
-       const unsigned int,
+       const size_type,
        const Point<deal_II_dimension> (&) [deal_II_dimension], 
        const bool);  
 
     template void
       GridGenerator::subdivided_parallelepiped<deal_II_dimension> (
        Triangulation<deal_II_dimension>&,
-       const unsigned int [deal_II_dimension], 
+       const size_type [deal_II_dimension], 
        const Point<deal_II_dimension> (&) [deal_II_dimension], 
        const bool);  
   
@@ -88,7 +88,7 @@ for (deal_II_dimension : DIMENSIONS)
   template void
     GridGenerator::
     laplace_transformation<deal_II_dimension> (Triangulation<deal_II_dimension> &,
-                                              const std::map<unsigned int,Point<deal_II_dimension> > &);
+                                              const std::map<types::global_dof_index,Point<deal_II_dimension> > &);
 #endif
   
   
index d27093c07317196480e83d9e71e640e532d96ff4..90db4382cec8bdfc55ee4a966f52845fab9bd69c 100644 (file)
@@ -605,7 +605,7 @@ namespace GridTools
 
   template <int dim>
   void
-  laplace_transform (const std::map<unsigned int,Point<dim> > &new_points,
+  laplace_transform (const std::map<types::global_dof_index,Point<dim> > &new_points,
                      Triangulation<dim> &triangulation)
   {
     //TODO: Move implementation of this function into the current
index 22aed5c106e65cc87d9a19fe32e6f3abcc998397..0a1d6e755824d536a0ee1fdf650c5524a532ea3c 100644 (file)
@@ -157,7 +157,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
 #if deal_II_dimension == deal_II_space_dimension  
     template
     void
-    laplace_transform (const std::map<unsigned int,Point<deal_II_dimension> > &new_points,
+    laplace_transform (const std::map<types::global_dof_index,Point<deal_II_dimension> > &new_points,
                        Triangulation<deal_II_dimension> &triangulation);
 
     template
index ae1d246e04416c066d4ead27f84e0db064c33a7a..608635a48317e5d952971b63de3df29565743ea6 100644 (file)
@@ -575,8 +575,9 @@ namespace internal
           for (unsigned int level=0; level<dof_handler.tria->n_levels(); ++level)
             {
               dof_handler.levels[level]->dof_object.dof_offsets
-                = std::vector<unsigned int> (dof_handler.tria->n_raw_lines(level),
-                                             DoFHandler<dim,spacedim>::invalid_dof_index);
+                = std::vector<types::global_dof_index> (
+                    dof_handler.tria->n_raw_lines(level),
+                    DoFHandler<dim,spacedim>::invalid_dof_index);
 
               types::global_dof_index next_free_dof = 0;
               for (typename DoFHandler<dim,spacedim>::active_cell_iterator
@@ -691,8 +692,9 @@ namespace internal
           for (unsigned int level=0; level<dof_handler.tria->n_levels(); ++level)
             {
               dof_handler.levels[level]->dof_object.dof_offsets
-                = std::vector<unsigned int> (dof_handler.tria->n_raw_quads(level),
-                                             DoFHandler<dim,spacedim>::invalid_dof_index);
+                = std::vector<types::global_dof_index> (
+                    dof_handler.tria->n_raw_quads(level),
+                    DoFHandler<dim,spacedim>::invalid_dof_index);
 
               types::global_dof_index next_free_dof = 0;
               for (typename DoFHandler<dim,spacedim>::active_cell_iterator
@@ -842,7 +844,7 @@ namespace internal
             // active ones will have a
             // non-invalid value later on
             dof_handler.faces->lines.dof_offsets
-              = std::vector<unsigned int> (dof_handler.tria->n_raw_lines(),
+              = std::vector<types::global_dof_index> (dof_handler.tria->n_raw_lines(),
                                            DoFHandler<dim,spacedim>::invalid_dof_index);
             dof_handler.faces->lines.dofs
               = std::vector<types::global_dof_index> (n_line_slots,
@@ -1055,7 +1057,7 @@ namespace internal
           for (unsigned int level=0; level<dof_handler.tria->n_levels(); ++level)
             {
               dof_handler.levels[level]->dof_object.dof_offsets
-                = std::vector<unsigned int> (dof_handler.tria->n_raw_hexs(level),
+                = std::vector<types::global_dof_index> (dof_handler.tria->n_raw_hexs(level),
                                              DoFHandler<dim,spacedim>::invalid_dof_index);
 
               types::global_dof_index next_free_dof = 0;
@@ -1210,7 +1212,7 @@ namespace internal
             if (true)
               {
                 dof_handler.faces->quads.dof_offsets
-                  = std::vector<unsigned int> (dof_handler.tria->n_raw_quads(),
+                  = std::vector<types::global_dof_index> (dof_handler.tria->n_raw_quads(),
                                                DoFHandler<dim,spacedim>::invalid_dof_index);
                 dof_handler.faces->quads.dofs
                   = std::vector<types::global_dof_index> (n_quad_slots,
@@ -1477,8 +1479,10 @@ namespace internal
         unsigned int
         max_couplings_between_dofs (const DoFHandler<1,spacedim> &dof_handler)
         {
-          return std::min(3*dof_handler.finite_elements->max_dofs_per_vertex() +
-                          2*dof_handler.finite_elements->max_dofs_per_line(), dof_handler.n_dofs());
+          return std::min(static_cast<types::global_dof_index> (3*
+                dof_handler.finite_elements->max_dofs_per_vertex() +
+                2*dof_handler.finite_elements->max_dofs_per_line()), 
+              dof_handler.n_dofs());
         }
 
 
@@ -1509,7 +1513,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:
@@ -1562,7 +1566,7 @@ namespace internal
           // can anyone give better estimate here?
           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.finite_elements->max_dofs_per_vertex() +
                           7*6*7*3*dof_handler.finite_elements->max_dofs_per_line() +
@@ -2673,8 +2677,8 @@ namespace hp
     Assert (number_cache.n_global_dofs < std::numeric_limits<unsigned int>::max (),
             ExcMessage ("Global number of degrees of freedom is too large."));
     number_cache.n_locally_owned_dofs_per_processor
-      = std::vector<unsigned int> (1,
-                                   (unsigned int) number_cache.n_global_dofs);
+      = std::vector<types::global_dof_index> (1,
+          (types::global_dof_index) number_cache.n_global_dofs);
 
     number_cache.locally_owned_dofs_per_processor
       = std::vector<IndexSet> (1,
index cb3e1759630ffc01b0211435ee196def025d5598..82721166079b1bf42caf2e76580f82efff919328 100644 (file)
@@ -21,21 +21,21 @@ for (deal_II_dimension : DIMENSIONS)
     template class DoFHandler<deal_II_dimension, deal_II_dimension+1>;
     
     template
-    unsigned int
+    types::global_dof_index
     DoFHandler<deal_II_dimension, deal_II_dimension+1>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
     
     template
     void
-    DoFHandler<deal_II_dimension, deal_II_dimension+1>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+    DoFHandler<deal_II_dimension, deal_II_dimension+1>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
     
     #if deal_II_dimension >= 2
     template
-    unsigned int
+    types::global_dof_index
     DoFHandler<deal_II_dimension, deal_II_dimension+1>::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
     
     template
     void
-    DoFHandler<deal_II_dimension, deal_II_dimension+1>::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+    DoFHandler<deal_II_dimension, deal_II_dimension+1>::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
     #endif
 #endif
 
@@ -43,43 +43,43 @@ for (deal_II_dimension : DIMENSIONS)
    template class DoFHandler<1, 3>;
 
 template
-unsigned int
+types::global_dof_index
 DoFHandler<1,3>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
 
 template
 void
-DoFHandler<1,3>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, unsigned int) const;
+DoFHandler<1,3>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
 #endif
 
 template
-unsigned int
+types::global_dof_index
 DoFHandler<deal_II_dimension>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
 
 #if deal_II_dimension >= 2
 template
-unsigned int
+types::global_dof_index
 DoFHandler<deal_II_dimension>::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
 
 #if deal_II_dimension >= 3
 template
-unsigned int
+types::global_dof_index
 DoFHandler<deal_II_dimension>::get_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
 #endif
 #endif
 
 template
 void
-DoFHandler<deal_II_dimension>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+DoFHandler<deal_II_dimension>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
 
 #if deal_II_dimension >= 2
 template
 void
-DoFHandler<deal_II_dimension>::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+DoFHandler<deal_II_dimension>::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
 
 #if deal_II_dimension >= 3
 template
 void
-DoFHandler<deal_II_dimension>::set_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+DoFHandler<deal_II_dimension>::set_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
 #endif
 #endif
   \}
index 0a08486187d81fb7a6a48b14cf61cb0a32ee44bf..d04b444c29414080c7efa8e5aeae768de9211f0c 100644 (file)
@@ -47,7 +47,7 @@ for (S1, S2 : REAL_SCALARS)
 
     template
       void FullMatrix<S1>::fill<S2> (
-       const FullMatrix<S2>&, unsigned, unsigned, unsigned, unsigned);
+       const FullMatrix<S2>&, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
     template
       void FullMatrix<S1>::add<S2> (const S1, const FullMatrix<S2>&);
     template
@@ -59,12 +59,12 @@ for (S1, S2 : REAL_SCALARS)
                                    const S1, const FullMatrix<S2>&);
     template
       void FullMatrix<S1>::add<S2> (
-       const FullMatrix<S2>&, S1, unsigned, unsigned,unsigned, unsigned);
+       const FullMatrix<S2>&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
     template
       void FullMatrix<S1>::Tadd<S2> (const S1, const FullMatrix<S2>&);
     template
       void FullMatrix<S1>::Tadd<S2> (
-       const FullMatrix<S2>&, S1, unsigned, unsigned, unsigned, unsigned);
+       const FullMatrix<S2>&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
     template
       void FullMatrix<S1>::equ<S2> (const S1, const FullMatrix<S2>&);
     template
@@ -93,8 +93,8 @@ for (S1, S2 : REAL_SCALARS)
     template
       void FullMatrix<S1>::fill_permutation<S2> (
        const FullMatrix<S2>&,
-       const std::vector<unsigned int>&,
-       const std::vector<unsigned int>&);
+       const std::vector<size_type>&,
+       const std::vector<size_type>&);
     template
       void FullMatrix<S1>::vmult<S2>(
       Vector<S2>&, const Vector<S2>&, bool) const;
@@ -155,7 +155,7 @@ for (S1, S2 : COMPLEX_SCALARS)
   {
     template
       void FullMatrix<S1>::fill<S2> (
-       const FullMatrix<S2>&, unsigned, unsigned, unsigned, unsigned);
+       const FullMatrix<S2>&, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
     template
       void FullMatrix<S1>::add<S2> (const S1, const FullMatrix<S2>&);
     template
@@ -167,12 +167,13 @@ for (S1, S2 : COMPLEX_SCALARS)
                                    const S1, const FullMatrix<S2>&);
     template
       void FullMatrix<S1>::add<S2> (
-       const FullMatrix<S2>&, S1, unsigned, unsigned,unsigned, unsigned);
+       const FullMatrix<S2>&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
     template
       void FullMatrix<S1>::Tadd<S2> (const S1, const FullMatrix<S2>&);
     template
       void FullMatrix<S1>::Tadd<S2> (
-       const FullMatrix<S2>&, S1, unsigned, unsigned, unsigned, unsigned);
+       const FullMatrix<S2>&, S1, types::global_dof_index, types::global_dof_index,
+  types::global_dof_index, types::global_dof_index);
     template
       void FullMatrix<S1>::equ<S2> (const S1, const FullMatrix<S2>&);
     template
@@ -197,8 +198,8 @@ for (S1, S2 : COMPLEX_SCALARS)
     template
       void FullMatrix<S1>::fill_permutation<S2> (
        const FullMatrix<S2>&,
-       const std::vector<unsigned int>&,
-       const std::vector<unsigned int>&);
+       const std::vector<size_type>&,
+       const std::vector<size_type>&);
     template
       void FullMatrix<S1>::vmult<S2>(
       Vector<S2>&, const Vector<S2>&, bool) const;
index d150412cd1f9cf67929201b15d76fdbe4a317bd4..dd62be2cbd931601eb4e9d01eff7c1e18b92f4e0 100644 (file)
@@ -150,7 +150,7 @@ namespace HSL
 
     extern "C"
     void ma47id_ (double *,
-                  size_type *)
+                  unsigned int *)
     {
       AssertThrow (false,
                    ExcMessage("You can only use the HSL functions after putting "
@@ -167,7 +167,7 @@ namespace HSL
                   size_type *,
                   const size_type *,
                   size_type *,
-                  const size_type *,
+                  const unsigned int *,
                   double *,
                   int *)
     {
@@ -188,7 +188,7 @@ namespace HSL
                   const size_type *,
                   const size_type *,
                   const double *,
-                  const size_type *,
+                  const unsigned int *,
                   size_type *,
                   double *,
                   int *)
@@ -209,7 +209,7 @@ namespace HSL
                   double *,
                   double *,
                   size_type *,
-                  const size_type *)
+                  const unsigned int *)
     {
       AssertThrow (false,
                    ExcMessage("You can only use the HSL functions after putting "
@@ -1409,8 +1409,8 @@ SparseDirectMA47::fill_A (const SparseMatrix<double> &matrix)
 
 
 void
-SparseDirectMA47::call_ma47id (double    *CNTL,   // length 2
-                               size_type *ICNTL)  // length 7
+SparseDirectMA47::call_ma47id (double       *CNTL,   // length 2
+                               unsigned int *ICNTL)  // length 7
 {
   HSL::MA47::ma47id_ (CNTL, ICNTL);
 }
index a958f2342405cedde3b40b0173bd6c55daf24de7..53eee7019166e49ec3ffe5e370e580f1f7491f1e 100644 (file)
@@ -32,16 +32,16 @@ for (S1, S2 : REAL_SCALARS)
     template void SparseMatrix<S1>::add<S2> (const S1,
                                             const SparseMatrix<S2> &);
 
-    template void SparseMatrix<S1>::add<S2> (const unsigned int,
-                                            const unsigned int,
-                                            const unsigned int *,
+    template void SparseMatrix<S1>::add<S2> (const size_type,
+                                            const size_type,
+                                            const size_type *,
                                             const S2 *,
                                             const bool,
                                             const bool);
 
-    template void SparseMatrix<S1>::set<S2> (const unsigned int,
-                                            const unsigned int,
-                                            const unsigned int *,
+    template void SparseMatrix<S1>::set<S2> (const size_type,
+                                            const size_type,
+                                            const size_type *,
                                             const S2 *,
                                             const bool);
   }
@@ -95,13 +95,13 @@ for (S1, S2 : REAL_SCALARS)
                const S1) const;
     template void SparseMatrix<S1>::
       PSOR<S2> (Vector<S2> &,
-               const std::vector<unsigned int>&,
-               const std::vector<unsigned int>&,
+               const std::vector<size_type>&,
+               const std::vector<size_type>&,
                const S1) const;
     template void SparseMatrix<S1>::
       TPSOR<S2> (Vector<S2> &,
-                const std::vector<unsigned int>&,
-                const std::vector<unsigned int>&,
+                const std::vector<size_type>&,
+                const std::vector<size_type>&,
                 const S1) const;
     template void SparseMatrix<S1>::
       Jacobi_step<S2> (Vector<S2> &,
@@ -215,13 +215,13 @@ for (S1, S2, S3: REAL_SCALARS)
 //             const S1) const;
 //     template void SparseMatrix<S1>::
 //       PSOR<S2> (Vector<S2> &,
-//             const std::vector<unsigned int>&,
-//             const std::vector<unsigned int>&,
+//             const std::vector<size_type>&,
+//             const std::vector<size_type>&,
 //             const S1) const;
 //     template void SparseMatrix<S1>::
 //       TPSOR<S2> (Vector<S2> &,
-//              const std::vector<unsigned int>&,
-//              const std::vector<unsigned int>&,
+//              const std::vector<size_type>&,
+//              const std::vector<size_type>&,
 //              const S1) const;
 //     template void SparseMatrix<S1>::
 //       SOR_step<S2> (Vector<S2> &,
index 26fbeb23eac6ba555df404d7fba38a35847b5944..9d80edb4dc8ff5ff37e5935c9f2f51c34ede1fd1 100644 (file)
@@ -384,7 +384,7 @@ SparsityPattern::reinit (const size_type m,
   std::size_t vec_len = 0;
   for (size_type i=0; i<m; ++i)
     vec_len += std::min((store_diagonal_first_in_row ?
-                         std::max(row_lengths[i], 1U) :
+                         std::max(row_lengths[i], static_cast<size_type> (1U)) :
                          row_lengths[i]),
                         n);
 
@@ -462,7 +462,7 @@ SparsityPattern::reinit (const size_type m,
   for (size_type i=1; i<=rows; ++i)
     rowstart[i] = rowstart[i-1] +
                   (store_diagonal_first_in_row ?
-                   std::max(std::min(row_lengths[i-1],n),1U) :
+                   std::max(std::min(row_lengths[i-1],n),static_cast<size_type> (1U)) :
                    std::min(row_lengths[i-1],n));
   Assert ((rowstart[rows]==vec_len)
           ||
index 1ed223ab8c471a79d1be94010bea1c71a7c8dab8..f543a81a0ce7841e204a3d438deaa4f606cd1887 100644 (file)
@@ -582,8 +582,8 @@ namespace MGTools
             ExcDimensionMismatch (sparsity.n_cols(), n_dofs));
 
     const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell;
-    std::vector<unsigned int> dofs_on_this_cell(dofs_per_cell);
-    std::vector<unsigned int> dofs_on_other_cell(dofs_per_cell);
+    std::vector<types::global_dof_index> dofs_on_this_cell(dofs_per_cell);
+    std::vector<types::global_dof_index> dofs_on_other_cell(dofs_per_cell);
     typename DoFHandler<dim,spacedim>::cell_iterator cell = dof.begin(level),
                                                      endc = dof.end(level);
     for (; cell!=endc; ++cell)
index 9a0b2b8c85870638ef4ad8033ee5f6a1b16fa30d..8e42bcdc6a1d6e9a7b95463dd533c8fcf31af032 100644 (file)
@@ -84,23 +84,23 @@ for (deal_II_dimension : DIMENSIONS)
 #endif
 
       template void count_dofs_per_component (
-       const DoFHandler<deal_II_dimension>&, std::vector<std::vector<unsigned int> >&,
-       bool, std::vector<unsigned int>);
+       const DoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
+       bool, std::vector<types::global_dof_index>);
       template void count_dofs_per_component (
-       const DoFHandler<deal_II_dimension>&, std::vector<std::vector<unsigned int> >&,
-       std::vector<unsigned int>);
+       const DoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
+       std::vector<types::global_dof_index>);
       template void count_dofs_per_block (
-       const DoFHandler<deal_II_dimension>&, std::vector<std::vector<unsigned int> >&,
-       std::vector<unsigned int>);
+       const DoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
+       std::vector<types::global_dof_index>);
       template void count_dofs_per_block (
-       const MGDoFHandler<deal_II_dimension>&, std::vector<std::vector<unsigned int> >&,
-       std::vector<unsigned int>);
+       const MGDoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
+       std::vector<types::global_dof_index>);
 
 #if deal_II_dimension > 1
       template void make_boundary_list(
        const DoFHandler<deal_II_dimension>&,
        const FunctionMap<deal_II_dimension>::type&,
-       std::vector<std::set<unsigned int> >&,
+       std::vector<std::set<types::global_dof_index> >&,
        const ComponentMask &);
 #endif
 
@@ -122,18 +122,18 @@ for (deal_II_dimension : DIMENSIONS)
       template
         void
         extract_non_interface_dofs (const DoFHandler<deal_II_dimension> & mg_dof_handler,
-                                    std::vector<std::set<unsigned int> > &non_interface_dofs);
+                                    std::vector<std::set<types::global_dof_index> > &non_interface_dofs);
 
 #if deal_II_dimension < 3
       template void count_dofs_per_block (
        const DoFHandler<deal_II_dimension,deal_II_dimension+1>&,
-       std::vector<std::vector<unsigned int> >&, std::vector<unsigned int>);
+       std::vector<std::vector<types::global_dof_index> >&, std::vector<types::global_dof_index>);
 #endif
 
 #if deal_II_dimension == 3
       template void count_dofs_per_block (
        const DoFHandler<1,3>&,
-       std::vector<std::vector<unsigned int> >&, std::vector<unsigned int>);
+       std::vector<std::vector<types::global_dof_index> >&, std::vector<types::global_dof_index>);
 #endif
     \}
   }
index bd9ad33004c19ff159bcaec6a203e81777ac10a3..272f78d8528d59164a703dfe291e5bd4b0c84069 100644 (file)
@@ -21,7 +21,7 @@ void MGTransferSelect<float>::build_matrices<deal_II_dimension>
  unsigned int, unsigned int,
  const std::vector<unsigned int>&,
  const std::vector<unsigned int>&,
- const std::vector<std::set<unsigned int> >&);
+ const std::vector<std::set<types::global_dof_index> >&);
 
 template
 void MGTransferSelect<double>::build_matrices<deal_II_dimension>
@@ -30,7 +30,7 @@ void MGTransferSelect<double>::build_matrices<deal_II_dimension>
  unsigned int, unsigned int,
  const std::vector<unsigned int>&,
  const std::vector<unsigned int>&,
- const std::vector<std::set<unsigned int> >&);
+ const std::vector<std::set<types::global_dof_index> >&);
 
 template void
 MGTransferSelect<float>::copy_to_mg (

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.