]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Convert unsigned int to types::global_dof_index. The first step of the tutorial compi...
authorturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 5 Mar 2013 15:12:51 +0000 (15:12 +0000)
committerturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 5 Mar 2013 15:12:51 +0000 (15:12 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28737 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/dofs/block_info.h
deal.II/include/deal.II/dofs/dof_renumbering.h
deal.II/include/deal.II/fe/fe_tools.h
deal.II/source/dofs/dof_renumbering.cc
deal.II/source/dofs/dof_tools.cc
deal.II/source/dofs/dof_tools.inst.in
deal.II/source/fe/fe_tools.cc
deal.II/source/fe/fe_tools.inst.in
deal.II/source/multigrid/mg_tools.cc
deal.II/source/multigrid/mg_tools.inst.in

index 835d5270e5b4a5186aeace165f4582ef99b9756c..b428e19ee2cd6b0ceed497cdccf60a2f1731a238 100644 (file)
@@ -158,7 +158,7 @@ public:
    * in the standard local
    * numbering of DoFAccessor.
    */
-  unsigned int renumber (const unsigned int i) const;
+  types::global_dof_index renumber (const types::global_dof_index i) const;
 
   /**
    * The number of base elements.
@@ -226,7 +226,7 @@ private:
    * ordering. Filled by
    * initialize().
    */
-  std::vector<unsigned int> local_renumbering;
+  std::vector<types::global_dof_index> local_renumbering;
 };
 
 
@@ -259,7 +259,7 @@ BlockInfo::level (const unsigned int l) const
 
 
 inline
-unsigned int BlockInfo::renumber (const unsigned int i) const
+types::global_dof_index BlockInfo::renumber (const types::global_dof_index i) const
 {
   AssertIndexRange(i, local_renumbering.size());
   return local_renumbering[i];
index f14d277bb2ebab32cacbb449a5c6217ea9b062e7..fc608becb27720e6a7f5ebca6062f1b9a3d43c8f 100644 (file)
@@ -919,7 +919,7 @@ namespace DoFRenumbering
    * the renumbering vector.
    */
   template <int dim, int spacedim, class ITERATOR, class ENDITERATOR>
-  unsigned int
+  types::global_dof_index
   compute_block_wise (std::vector<types::global_dof_index> &new_dof_indices,
                       const ITERATOR &start,
                       const ENDITERATOR &end);
index 99b067105271e139c2541d0f2265fcaa27eef818..364d83b55ffb4050e35ef7c311df5190e6e716f9 100644 (file)
@@ -169,7 +169,7 @@ namespace FETools
   template<int dim, int spacedim>
   void compute_block_renumbering (
     const FiniteElement<dim,spacedim> &fe,
-    std::vector<unsigned int> &renumbering,
+    std::vector<types::global_dof_index> &renumbering,
     std::vector<types::global_dof_index> &block_data,
     bool return_start_indices = true);
 
index e0c3402c8e4a4739ade85bc2439afed196e78449..618c6cbdfdf8e0a27c98b7dbf9c0c091bbf5517e 100644 (file)
@@ -1070,13 +1070,13 @@ namespace DoFRenumbering
     types::global_dof_index next_free_index = 0;
     for (unsigned int block=0; block<fe_collection.n_blocks(); ++block)
       {
-        const typename std::vector<unsigned int>::const_iterator
+        const typename std::vector<types::global_dof_index>::const_iterator
         begin_of_component = block_to_dof_map[block].begin(),
         end_of_component   = block_to_dof_map[block].end();
 
         next_free_index = shifts[block];
 
-        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 fbbfc216fb188760159023236309de1cb131ce9b..ae3fb7e44c91dc3ab6ea66fd0e4a08daefaadbe0 100644 (file)
@@ -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<types::global_dof_index> &target_block_)
+                        const std::vector<unsigned int> &target_block_)
   {
-    std::vector<types::global_dof_index>  target_block = target_block_;
+    std::vector<unsigned int>  target_block = target_block_;
 
     const dealii::hp::FECollection<DH::dimension,DH::space_dimension>
     fe_collection (dof_handler.get_fe());
index d2c6af3fb3db2ea85f3031d15306970297fa1b80..124592fb4fad8b17d3f2d3e6b5105b7f031f9c3f 100644 (file)
@@ -877,21 +877,21 @@ void
 DoFTools::count_dofs_per_block<DoFHandler<deal_II_dimension> > (
   const DoFHandler<deal_II_dimension>&,
   std::vector<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 template
 void
 DoFTools::count_dofs_per_block<hp::DoFHandler<deal_II_dimension> > (
   const hp::DoFHandler<deal_II_dimension>&,
   std::vector<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 template
 void
 DoFTools::count_dofs_per_block<MGDoFHandler<deal_II_dimension> > (
   const MGDoFHandler<deal_II_dimension>&,
   std::vector<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 template
 void
@@ -1013,21 +1013,21 @@ 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<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 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<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 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<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 #endif
 
@@ -1046,21 +1046,21 @@ void
 DoFTools::count_dofs_per_block<DoFHandler<1,3> > (
   const DoFHandler<1,3>&,
   std::vector<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 template
 void
 DoFTools::count_dofs_per_block<hp::DoFHandler<1,3> > (
   const hp::DoFHandler<1,3>&,
   std::vector<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 template
 void
 DoFTools::count_dofs_per_block<MGDoFHandler<1,3> > (
   const MGDoFHandler<1,3>&,
   std::vector<types::global_dof_index>&,
-  const std::vector<types::global_dof_index> &);
+  const std::vector<unsigned int> &);
 
 #endif
 
index ec3cc55d50e39fe36cd37677787e966d065b0416..dfa3fda6c7b5baeb92e8c26259bd9656b0a36ce9 100644 (file)
@@ -359,8 +359,8 @@ namespace FETools
   template<int dim, int spacedim>
   void compute_block_renumbering (
     const FiniteElement<dim,spacedim> &element,
-    std::vector<unsigned int> &renumbering,
-    std::vector<unsigned int> &block_data,
+    std::vector<types::global_dof_index> &renumbering,
+    std::vector<types::global_dof_index> &block_data,
     bool return_start_indices)
   {
     Assert(renumbering.size() == element.dofs_per_cell,
@@ -396,7 +396,7 @@ namespace FETools
 //TODO:[GK] This does not work for a single RT
     for (unsigned int i=0; i<element.dofs_per_cell; ++i)
       {
-        std::pair<unsigned int, unsigned int>
+        std::pair<types::global_dof_index, types::global_dof_index>
         indices = element.system_to_block_index(i);
         renumbering[i] = start_indices[indices.first]
                          +indices.second;
index f54ca54f595da18da3900511b9160065b05465e5..981bd71c246cbce3eab100794fa7c41f1b177b54 100644 (file)
@@ -20,7 +20,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
       template
        void compute_block_renumbering (
          const FiniteElement<deal_II_dimension,deal_II_space_dimension>& ,
-         std::vector<unsigned int>&, std::vector<unsigned int>&, bool);
+         std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>&, bool);
 
       template
        void compute_projection_matrices<deal_II_dimension, double, deal_II_space_dimension>
index f543a81a0ce7841e204a3d438deaa4f606cd1887..d014a814a2554f6f5744b77828284486135bab4c 100644 (file)
@@ -1059,7 +1059,7 @@ namespace MGTools
   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<unsigned int>  target_block)
   {
     const FiniteElement<DH::dimension,DH::space_dimension> &fe = dof_handler.get_fe();
     const unsigned int n_blocks = fe.n_blocks();
index 8e42bcdc6a1d6e9a7b95463dd533c8fcf31af032..eb1926c14b2164d4da005b941892972b9e2fca1e 100644 (file)
@@ -91,10 +91,10 @@ for (deal_II_dimension : DIMENSIONS)
        std::vector<types::global_dof_index>);
       template void count_dofs_per_block (
        const DoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
-       std::vector<types::global_dof_index>);
+       std::vector<unsigned int>);
       template void count_dofs_per_block (
        const MGDoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
-       std::vector<types::global_dof_index>);
+       std::vector<unsigned int>);
 
 #if deal_II_dimension > 1
       template void make_boundary_list(

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.