]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Apply a few patches rescued from a previous branch. This probably only covers a small...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 9 Aug 2012 20:28:54 +0000 (20:28 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 9 Aug 2012 20:28:54 +0000 (20:28 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_3@25842 0785d39b-7218-0410-832d-ea1e28bc413d

83 files changed:
deal.II/examples/step-18/step-18.cc
deal.II/examples/step-4/step-4.cc
deal.II/examples/step-42/step-42.cc
deal.II/examples/step-5/step-5.cc
deal.II/examples/step-6/step-6.cc
deal.II/include/deal.II/base/utilities.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_tools.h
deal.II/include/deal.II/multigrid/mg_dof_handler.h
deal.II/source/base/index_set.cc
deal.II/source/base/utilities.cc
deal.II/source/dofs/dof_accessor.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_renumbering.cc
deal.II/source/dofs/dof_renumbering.inst.in
deal.II/source/dofs/dof_tools.inst.in
deal.II/source/numerics/point_value_history.cc
tests/benchmarks/spec2006-447.dealII.cc
tests/bits/anna_1.cc
tests/bits/anna_2.cc
tests/bits/get_dof_indices_01.cc
tests/bits/joa_1.cc
tests/bits/step-13.cc
tests/bits/step-14.cc
tests/bits/step-15.cc
tests/bits/step-16.cc
tests/bits/step-3.cc
tests/bits/step-4.cc
tests/bits/step-5.cc
tests/bits/step-6.cc
tests/bits/step-7.cc
tests/bits/step-8.cc
tests/codim_one/bem.cc
tests/codim_one/gradients.cc
tests/deal.II/block_matrices.cc
tests/deal.II/fe_values_view_21.cc
tests/deal.II/fe_values_view_22.cc
tests/deal.II/inhomogeneous_constraints.cc
tests/deal.II/inhomogeneous_constraints_block.cc
tests/deal.II/inhomogeneous_constraints_nonsymmetric.cc
tests/deal.II/inhomogeneous_constraints_vector.cc
tests/deal.II/point_value_history_01.cc
tests/distributed_grids/2d_dofhandler_01.cc
tests/fail/circular_01.cc
tests/fail/hp-step-14.cc
tests/fail/hp-step-15.cc
tests/fe/abf_01.cc
tests/fe/deformed_projection.h
tests/fe/non_primitive_1.cc
tests/fe/non_primitive_2.cc
tests/fe/rt_normal_02.cc
tests/hp/compare_hp_vs_nonhp_01.cc
tests/hp/continuous_1d_01.cc
tests/hp/continuous_2d_01.cc
tests/hp/continuous_3d_01.cc
tests/hp/crash_05.cc
tests/hp/crash_17.cc
tests/hp/crash_17_compressed_set_sparsity.cc
tests/hp/crash_18.cc
tests/hp/crash_18_compressed_set_sparsity.cc
tests/hp/random.cc
tests/hp/step-13.cc
tests/hp/step-3.cc
tests/hp/step-3a.cc
tests/hp/step-3b.cc
tests/hp/step-3c.cc
tests/hp/step-4.cc
tests/hp/step-5.cc
tests/hp/step-6.cc
tests/hp/step-7.cc
tests/hp/step-8.cc
tests/mpi/p4est_2d_dofhandler_01.cc
tests/mpi/p4est_2d_dofhandler_03.cc
tests/mpi/p4est_2d_dofhandler_04.cc
tests/mpi/p4est_2d_renumber_01.cc
tests/mpi/p4est_2d_renumber_02.cc
tests/multigrid/renumbering_01.cc
tests/multigrid/step-16.cc
tests/umfpack/umfpack_04.cc

index 0297cdfab857fe4ac0b63045f3cb5cedb4073112..5482c16010e2976b5253afb72e656b348385b7cb 100644 (file)
@@ -1481,7 +1481,7 @@ namespace Step18
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       cell_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     BodyForce<dim>      body_force;
     std::vector<Vector<double> > body_force_values (n_q_points,
index 40bf96d41ce7a706be77c212c58aff3dd2b821f1..2106b15f381569ae4fa568918a9c0d3e8f375108 100644 (file)
@@ -437,7 +437,7 @@ void Step4<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
                                    // Next, we again have to loop over all
                                    // cells and assemble local contributions.
index 1f434510dd6d86bb5659dc7c7e9454348c846ebb..02b0ead735104f1e7c46badaf67c4510bba4a06c 100644 (file)
@@ -638,7 +638,7 @@ void Step4<dim>::assemble_mass_matrix ()
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const FEValuesExtractors::Vector displacement (0);
 
@@ -700,7 +700,7 @@ void Step4<dim>::assemble_nl_system (TrilinosWrappers::MPI::Vector &u)
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   typename DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active(),
                                                 endc = dof_handler.end();
index c5bd15aedf7dd64ebd253a990d721194bb727507..0eb8ec03dd3d48b3ce02647079aa0c648cb8a8be 100644 (file)
@@ -442,7 +442,7 @@ void Step5<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
                                    // Here is one difference: for this
                                    // program, we will again use a
index fca0d404aa1c6ddb68117fd0d30bcc8a1f1a59dc..4a3ea005e52b5ccaf0dfbc0e55f570ab7da2d1e8 100644 (file)
@@ -563,7 +563,7 @@ void Step6<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
index 8bd5a226a9095531625b67b68f47a8c70330bbae..280f18208a5abc1e6369e4ea1118d995e0788fed 100644 (file)
@@ -642,6 +642,45 @@ namespace Utilities
 
 #endif
 
+
+  template <typename Integer>
+  std::vector<Integer>
+  reverse_permutation (const std::vector<Integer> &permutation)
+  {
+    const unsigned int n = permutation.size();
+
+    std::vector<Integer> out (n);
+    for (unsigned int i=0; i<n; ++i)
+      out[i] = n - 1 - permutation[i];
+
+    return out;
+  }
+
+
+
+  template <typename Integer>
+  std::vector<Integer>
+  invert_permutation (const std::vector<Integer> &permutation)
+  {
+    const unsigned int n = permutation.size();
+
+    std::vector<Integer> out (n, numbers::invalid_unsigned_int);
+
+    for (unsigned 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 int i=0; i<n; ++i)
+      Assert (out[i] != numbers::invalid_unsigned_int,
+             ExcMessage ("The given input permutation had duplicate entries!"));
+
+    return out;
+  }
+  
 }
 
 
index 07360dc63a4a6a53eb1ec16e64475f5bd060fefd..d528221100d148acfd9e7b43d7c586b29f573f5a 100644 (file)
@@ -1434,7 +1434,7 @@ namespace internal
 
 template <int dim, class DH>
 inline
-unsigned int
+types::global_dof_index
 DoFAccessor<dim,DH>::dof_index (const unsigned int i,
                                                const unsigned int fe_index) const
 {
@@ -1526,7 +1526,7 @@ DoFAccessor<dim,DH>::fe_index_is_active (const unsigned int fe_index) const
 
 template <int structdim, class DH>
 inline
-unsigned int
+types::global_dof_index
 DoFAccessor<structdim, DH>::vertex_dof_index (const unsigned int vertex,
                                                                  const unsigned int i,
                                                                  const unsigned int fe_index) const
@@ -2034,7 +2034,7 @@ get_dof_indices (std::vector<unsigned int> &dof_indices,
 
 template <template <int, int> class DH, int spacedim>
 inline
-unsigned int
+types::global_dof_index
 DoFAccessor<0,DH<1,spacedim> >::
 vertex_dof_index (const unsigned int vertex,
                          const unsigned int i,
@@ -3287,7 +3287,7 @@ template <class DH>
 inline
 void
 DoFCellAccessor<DH>::
-get_dof_indices (std::vector<unsigned int> &dof_indices) const
+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 db1a7196fc39a776fb525e9dc59340682a3bb8eb..12672439152e35e0cbc03c2efa92364ed1816e43 100644 (file)
@@ -136,7 +136,7 @@ namespace internal
  * respective degree of freedom shall be assigned. This number may, for
  * example, be obtained by sorting the support points of the degrees of
  * freedom in downwind direction.  Then call the
- * <tt>renumber_dofs(vector<unsigned int>)</tt> function with the array, which
+ * <tt>renumber_dofs(vector<types::global_dof_index>)</tt> function with the array, which
  * converts old into new degree of freedom indices.
  *
  *
@@ -1467,7 +1467,7 @@ template <> unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<types::b
 
 template <int dim, int spacedim>
 inline
-unsigned int
+types::global_dof_index
 DoFHandler<dim,spacedim>::n_dofs () const
 {
   return number_cache.n_global_dofs;
@@ -1481,7 +1481,7 @@ unsigned int DoFHandler<dim, spacedim>::n_dofs (const unsigned int level) const
 }
 
 template <int dim, int spacedim>
-unsigned int
+types::global_dof_index
 DoFHandler<dim, spacedim>::n_locally_owned_dofs() const
 {
   return number_cache.n_locally_owned_dofs;
@@ -1497,7 +1497,7 @@ DoFHandler<dim, spacedim>::locally_owned_dofs() const
 
 
 template <int dim, int spacedim>
-const std::vector<unsigned int> &
+const std::vector<types::global_dof_index> &
 DoFHandler<dim, spacedim>::n_locally_owned_dofs_per_processor() const
 {
   return number_cache.n_locally_owned_dofs_per_processor;
index 35015fb6d4ac0b146680859ef15433f9b005c4da..91a9475512c62345d64a81d604f662974b62de47 100644 (file)
@@ -63,7 +63,7 @@ namespace internal
                                           * Store the global indices of
                                           * the degrees of freedom.
                                           */
-        std::vector<unsigned int> dofs;
+        std::vector<types::global_dof_index> dofs;
 
       public:
                                          /**
@@ -218,7 +218,7 @@ namespace internal
     template <int dim>
     template <int dh_dim, int spacedim>
     inline
-    unsigned int
+    types::global_dof_index
     DoFObjects<dim>::
     get_dof_index (const dealii::DoFHandler<dh_dim,spacedim> &dof_handler,
                    const unsigned int       obj_index,
index 75caa20de6ab5bba21bc0c45a07a797438b0d006..a676aa304f1c59c09af8f8e0750e57e9bc652c36 100644 (file)
@@ -207,7 +207,7 @@ namespace FETools
   void compute_block_renumbering (
     const FiniteElement<dim,spacedim>&  fe,
     std::vector<unsigned int>& renumbering,
-    std::vector<unsigned int>& block_data,
+    std::vector<types::global_dof_index>& block_data,
     bool return_start_indices = true);
 
                                    /**
index aa0bf6b665e184fd0deabfce556902aacd287316..471bb19a7902daa7cfe45808c1bfac71f7bf8364 100644 (file)
@@ -1022,7 +1022,7 @@ class MGDoFHandler : public DoFHandler<dim,spacedim>
 
 template <int dim, int spacedim>
 inline
-unsigned int MGDoFHandler<dim,spacedim>::n_dofs() const
+types::global_dof_index MGDoFHandler<dim,spacedim>::n_dofs() const
 {
   return DoFHandler<dim,spacedim>::n_dofs();
 }
@@ -1030,7 +1030,7 @@ unsigned int MGDoFHandler<dim,spacedim>::n_dofs() const
 
 template <int dim, int spacedim>
 inline
-void MGDoFHandler<dim,spacedim>::renumber_dofs (const std::vector<unsigned int> &new_numbers)
+void MGDoFHandler<dim,spacedim>::renumber_dofs (const std::vector<types::global_dof_index> &new_numbers)
 {
   return DoFHandler<dim,spacedim>::renumber_dofs (new_numbers);
 }
@@ -1055,7 +1055,7 @@ void MGDoFHandler<dim,spacedim>::MGVertexDoFs::set_index  (const unsigned int le
 
 template <int dim, int spacedim>
 inline
-unsigned int
+types::global_dof_index
 MGDoFHandler<dim,spacedim>::MGVertexDoFs::get_index  (const unsigned int level,
                                              const unsigned int dof_number,
                                              const unsigned int dofs_per_vertex) const {
index 3e51051a27039e55ad0ad50d1cead2f6ee5ba789..8fc02d8530084cd8e4070726d3d9ab3968ef8323 100644 (file)
@@ -42,8 +42,8 @@ IndexSet::do_compress () const
         next = i;
       ++next;
 
-      unsigned int first_index = i->begin;
-      unsigned int last_index  = i->end;
+      types::global_dof_index first_index = i->begin;
+      types::global_dof_index last_index  = i->end;
 
                                        // see if we can merge any of
                                        // the following ranges
@@ -226,12 +226,15 @@ IndexSet::write(std::ostream & out) const
 void
 IndexSet::read(std::istream & in)
 {
-  unsigned int s, numranges, b, e;
+  types::global_dof_index s;
+  unsigned int numranges;
+  
   in >> s >> numranges;
   ranges.clear();
   set_size(s);
   for (unsigned int i=0;i<numranges;++i)
     {
+      types::global_dof_index b, e;
       in >> b >> e;
       add_range(b,e);
     }
@@ -256,7 +259,7 @@ IndexSet::block_write(std::ostream & out) const
 void
 IndexSet::block_read(std::istream & in)
 {
-  unsigned int size;
+  types::global_dof_index size;
   size_t n_ranges;
   in.read(reinterpret_cast<char*>(&size), sizeof(size));
   in.read(reinterpret_cast<char*>(&n_ranges), sizeof(n_ranges));
@@ -352,7 +355,7 @@ IndexSet::subtract_set (const IndexSet & other)
 }
 
 
-void IndexSet::fill_index_vector(std::vector<unsigned int> & indices) const
+void IndexSet::fill_index_vector(std::vector<types::global_dof_index> & indices) const
 {
   compress();
 
@@ -362,7 +365,7 @@ void IndexSet::fill_index_vector(std::vector<unsigned int> & indices) const
   for (std::vector<Range>::iterator it = ranges.begin();
        it != ranges.end();
        ++it)
-    for (unsigned int i=it->begin; i<it->end; ++i)
+    for (types::global_dof_index i=it->begin; i<it->end; ++i)
       indices.push_back (i);
 
   Assert (indices.size() == n_elements(), ExcInternalError());
@@ -418,9 +421,9 @@ IndexSet::make_trilinos_map (const MPI_Comm &communicator,
 std::size_t
 IndexSet::memory_consumption () const
 {
-  return MemoryConsumption::memory_consumption (ranges) +
-    MemoryConsumption::memory_consumption (is_compressed) +
-    MemoryConsumption::memory_consumption (index_space_size);
+  return (MemoryConsumption::memory_consumption (ranges) +
+         MemoryConsumption::memory_consumption (is_compressed) +
+         MemoryConsumption::memory_consumption (index_space_size));
 }
 
 
index 4cd05eb695172ec11a03750b7a6328ae6b1e8d6c..605d8821f4454d3149f587fff60dc4fb870c20b8 100644 (file)
@@ -468,6 +468,46 @@ namespace Utilities
   }
 
 
+  template <typename Integer>
+  std::vector<Integer>
+  reverse_permutation (const std::vector<Integer> &permutation)
+  {
+    const unsigned int n = permutation.size();
+
+    std::vector<Integer> out (n);
+    for (unsigned int i=0; i<n; ++i)
+      out[i] = n - 1 - permutation[i];
+
+    return out;
+  }
+
+
+
+  template <typename Integer>
+  std::vector<Integer>
+  invert_permutation (const std::vector<Integer> &permutation)
+  {
+    const unsigned int n = permutation.size();
+
+    std::vector<Integer> out (n, numbers::invalid_unsigned_int);
+
+    for (unsigned 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 int i=0; i<n; ++i)
+      Assert (out[i] != numbers::invalid_unsigned_int,
+             ExcMessage ("The given input permutation had duplicate entries!"));
+
+    return out;
+  }
+
+
+
 
   namespace System
   {
index b9157eb7b7798c0446c9208f51ddb216feea098a..5162b67a3f91bd941e7578361b89bc39daad3bdd 100644 (file)
@@ -59,7 +59,7 @@ DoFCellAccessor<DH>::update_cell_dof_indices_cache () const
 
 template <class DH>
 void
-DoFCellAccessor<DH>::set_dof_indices (const std::vector<unsigned int> &local_dof_indices)
+DoFCellAccessor<DH>::set_dof_indices (const std::vector<types::global_dof_index> &local_dof_indices)
 {
   Assert (static_cast<unsigned int>(this->present_level) < this->dof_handler->levels.size(),
           ExcMessage ("DoFHandler not initialized"));
index a7d769c0df690298ff472f098e76ce9452b01aef..0e5146ac241852b4bbbec6dee110b6b2c6b89de0 100644 (file)
@@ -42,7 +42,7 @@ template<int dim, int spacedim>
 const unsigned int DoFHandler<dim,spacedim>::space_dimension;
 
 template <int dim, int spacedim>
-const unsigned int DoFHandler<dim,spacedim>::invalid_dof_index;
+const types::global_dof_index DoFHandler<dim,spacedim>::invalid_dof_index;
 
 template <int dim, int spacedim>
 const unsigned int DoFHandler<dim,spacedim>::default_fe_index;
@@ -53,7 +53,7 @@ const unsigned int DoFHandler<dim,spacedim>::default_fe_index;
 namespace internal
 {
   template <int dim, int spacedim>
-  const unsigned int * dummy ()
+  const types::global_dof_index * dummy ()
   {
     return &dealii::DoFHandler<dim,spacedim>::invalid_dof_index;
   }
@@ -1795,7 +1795,7 @@ DoFHandler<dim, spacedim>::last_active_hex () const
 
 
 template <>
-unsigned int DoFHandler<1>::n_boundary_dofs () const
+types::global_dof_index DoFHandler<1>::n_boundary_dofs () const
 {
   return 2*get_fe().dofs_per_vertex;
 }
@@ -1803,7 +1803,7 @@ unsigned int DoFHandler<1>::n_boundary_dofs () const
 
 
 template <>
-unsigned int DoFHandler<1>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
+types::global_dof_index DoFHandler<1>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
 {
                                    // check that only boundary
                                    // indicators 0 and 1 are allowed
@@ -1834,7 +1834,7 @@ unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<types::boundary_id_t
 
 
 template <>
-unsigned int DoFHandler<1,2>::n_boundary_dofs () const
+types::global_dof_index DoFHandler<1,2>::n_boundary_dofs () const
 {
   return 2*get_fe().dofs_per_vertex;
 }
@@ -1842,7 +1842,7 @@ unsigned int DoFHandler<1,2>::n_boundary_dofs () const
 
 
 template <>
-unsigned int DoFHandler<1,2>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
+types::global_dof_index DoFHandler<1,2>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
 {
                                    // check that only boundary
                                    // indicators 0 and 1 are allowed
@@ -1874,12 +1874,12 @@ unsigned int DoFHandler<1,2>::n_boundary_dofs (const std::set<types::boundary_id
 
 
 template<int dim, int spacedim>
-unsigned int DoFHandler<dim,spacedim>::n_boundary_dofs () const
+types::global_dof_index DoFHandler<dim,spacedim>::n_boundary_dofs () const
 {
   std::set<int> boundary_dofs;
 
   const unsigned int dofs_per_face = get_fe().dofs_per_face;
-  std::vector<unsigned int> dofs_on_face(dofs_per_face);
+  std::vector<types::global_dof_index> dofs_on_face(dofs_per_face);
 
                                    // loop over all faces to check
                                    // whether they are at a
@@ -1906,7 +1906,7 @@ unsigned int DoFHandler<dim,spacedim>::n_boundary_dofs () const
 
 
 template<int dim, int spacedim>
-unsigned int
+types::global_dof_index
 DoFHandler<dim,spacedim>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
 {
   Assert (boundary_indicators.find(types::internal_face_boundary_id) == boundary_indicators.end(),
@@ -1915,7 +1915,7 @@ DoFHandler<dim,spacedim>::n_boundary_dofs (const FunctionMap &boundary_indicator
   std::set<int> boundary_dofs;
 
   const unsigned int dofs_per_face = get_fe().dofs_per_face;
-  std::vector<unsigned int> dofs_on_face(dofs_per_face);
+  std::vector<types::global_dof_index> dofs_on_face(dofs_per_face);
   active_face_iterator face = begin_active_face (),
                               endf = end_face();
   for (; face!=endf; ++face)
@@ -1941,7 +1941,7 @@ DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<types::boundary_id_t>
   std::set<int> boundary_dofs;
 
   const unsigned int dofs_per_face = get_fe().dofs_per_face;
-  std::vector<unsigned int> dofs_on_face(dofs_per_face);
+  std::vector<types::global_dof_index> dofs_on_face(dofs_per_face);
   active_face_iterator face = begin_active_face (),
                               endf = end_face();
   for (; face!=endf; ++face)
@@ -2099,7 +2099,7 @@ void DoFHandler<dim,spacedim>::clear ()
 template <int dim, int spacedim>
 void
 DoFHandler<dim,spacedim>::
-renumber_dofs (const std::vector<unsigned int> &new_numbers)
+renumber_dofs (const std::vector<types::global_dof_index> &new_numbers)
 {
   Assert (new_numbers.size() == n_locally_owned_dofs(),
              ExcRenumberingIncomplete());
@@ -2192,7 +2192,7 @@ void DoFHandler<dim,spacedim>::clear_space ()
   delete faces;
   faces = 0;
 
-  std::vector<unsigned int> tmp;
+  std::vector<types::global_dof_index> tmp;
   std::swap (vertex_dofs, tmp);
 }
 
index d68a703e7a5072c9ddc9c3e2994fbc5b8edcad04..c35ac007c7f89207ab25fb3455c28851eda5a910 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -16,9 +16,9 @@ for (deal_II_dimension : DIMENSIONS)
   {
     namespace internal
     \{
-      template const unsigned int * dummy<deal_II_dimension,deal_II_dimension> ();
+      template const types::global_dof_index * dummy<deal_II_dimension,deal_II_dimension> ();
 #if deal_II_dimension < 3
-      template const unsigned int * dummy<deal_II_dimension,deal_II_dimension+1> ();
+      template const types::global_dof_index * dummy<deal_II_dimension,deal_II_dimension+1> ();
 #endif
     \}
 
index b2563c8dbe4dd30f3f10e2d12def6e0b887b01d7..9335c160ad02dc7ef814cefcebd020005f9ce1d5 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006, 2010 by the deal.II authors
+//    Copyright (C) 2006, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -21,7 +21,7 @@ for (deal_II_dimension : DIMENSIONS)
 for (deal_II_dimension, structdim : DIMENSIONS)
   {
     template
-    unsigned int
+    types::global_dof_index
     DoFObjects<structdim>::
     get_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
                   const unsigned int       obj_index,
@@ -35,12 +35,12 @@ 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);
 
 #if (deal_II_dimension < 3) && (structdim < 3)
 
     template
-    unsigned int
+    types::global_dof_index
     DoFObjects<structdim>::
     get_dof_index (const dealii::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
                   const unsigned int       obj_index,
@@ -75,7 +75,7 @@ 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
   }
 
index 9e3b71a732c2168ecb15626116322b6a10f52b19..4bc604131700948709e87a8c83157460f4a776c2 100644 (file)
@@ -358,7 +358,7 @@ namespace DoFRenumbering
 
       Graph G(n);
 
-      std::vector<unsigned int> dofs_on_this_cell;
+      std::vector<dealii::types::global_dof_index> dofs_on_this_cell;
 
       typename DH::active_cell_iterator cell = dof_handler.begin_active(),
                                         endc = dof_handler.end();
@@ -524,7 +524,7 @@ namespace DoFRenumbering
                               dof_handler.max_couplings_between_dofs());
     MGTools::make_sparsity_pattern (dof_handler, sparsity, level);
 
-    std::vector<unsigned int> new_indices(sparsity.n_rows());
+    std::vector<types::global_dof_index> new_indices(sparsity.n_rows());
     SparsityTools::reorder_Cuthill_McKee (sparsity, new_indices,
                                           starting_indices);
 
@@ -558,7 +558,7 @@ namespace DoFRenumbering
     const typename DoFHandler<dim,spacedim>::cell_iterator
       end = dof_handler.end();
 
-    const unsigned int result =
+    const types::global_dof_index result =
       compute_component_wise<dim, spacedim, ITERATOR,
       typename DoFHandler<dim,spacedim>::cell_iterator>
       (renumbering, start, end, component_order_arg);
@@ -601,7 +601,7 @@ namespace DoFRenumbering
     const typename hp::DoFHandler<dim>::cell_iterator
       end = dof_handler.end();
 
-    const unsigned int result =
+    const types::global_dof_index result =
       compute_component_wise<dim, dim, ITERATOR,
       typename hp::DoFHandler<dim>::cell_iterator>(renumbering,
                                                    start, end,
@@ -636,7 +636,7 @@ namespace DoFRenumbering
       iend = dof_handler.end(level);
     const ITERATOR end = iend;
 
-    const unsigned int result =
+    const types::global_dof_index result =
       compute_component_wise<dim, dim, ITERATOR, ITERATOR>(
         renumbering, start, end, component_order_arg);
 
@@ -1080,8 +1080,8 @@ namespace DoFRenumbering
   cell_wise_dg (DH& dof,
                 const std::vector<typename DH::cell_iterator>& cells)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs());
-    std::vector<unsigned int> reverse(dof.n_dofs());
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs());
+    std::vector<types::global_dof_index> reverse(dof.n_dofs());
     compute_cell_wise_dg(renumbering, reverse, dof, cells);
 
     dof.renumber_dofs(renumbering);
@@ -1095,8 +1095,8 @@ namespace DoFRenumbering
     DH& dof,
     const std::vector<typename DH::cell_iterator>& cells)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs());
-    std::vector<unsigned int> reverse(dof.n_dofs());
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs());
+    std::vector<types::global_dof_index> reverse(dof.n_dofs());
     compute_cell_wise(renumbering, reverse, dof, cells);
 
     dof.renumber_dofs(renumbering);
@@ -1107,8 +1107,8 @@ namespace DoFRenumbering
   template <class DH>
   void
   compute_cell_wise_dg (
-    std::vector<unsigned int>& new_indices,
-    std::vector<unsigned int>& reverse,
+    std::vector<types::global_dof_index>& new_indices,
+    std::vector<types::global_dof_index>& reverse,
     const DH& dof,
     const typename std::vector<typename DH::cell_iterator>& cells)
   {
@@ -1116,7 +1116,7 @@ namespace DoFRenumbering
            ExcDimensionMismatch(cells.size(),
                                 dof.get_tria().n_active_cells()));
 
-    unsigned int n_global_dofs = dof.n_dofs();
+    types::global_dof_index n_global_dofs = dof.n_dofs();
 
                                      // Actually, we compute the
                                      // inverse of the reordering
@@ -1130,9 +1130,9 @@ namespace DoFRenumbering
     Assert(reverse.size() == n_global_dofs,
            ExcDimensionMismatch(reverse.size(), n_global_dofs));
 
-    std::vector<unsigned int> cell_dofs;
+    std::vector<types::global_dof_index> cell_dofs;
 
-    unsigned int global_index = 0;
+    types::global_dof_index global_index = 0;
 
     typename std::vector<typename DH::cell_iterator>::const_iterator cell;
 
@@ -1161,7 +1161,7 @@ namespace DoFRenumbering
       }
     Assert(global_index == n_global_dofs, ExcRenumberingIncomplete());
 
-    for (unsigned int i=0;i<reverse.size(); ++i)
+    for (types::global_dof_index i=0;i<reverse.size(); ++i)
       new_indices[reverse[i]] = i;
   }
 
@@ -1169,8 +1169,8 @@ namespace DoFRenumbering
   template <class DH>
   void
   compute_cell_wise (
-    std::vector<unsigned int>& new_indices,
-    std::vector<unsigned int>& reverse,
+    std::vector<types::global_dof_index>& new_indices,
+    std::vector<types::global_dof_index>& reverse,
     const DH& dof,
     const typename std::vector<typename DH::cell_iterator>& cells)
   {
@@ -1178,7 +1178,7 @@ namespace DoFRenumbering
            ExcDimensionMismatch(cells.size(),
                                 dof.get_tria().n_active_cells()));
 
-    unsigned int n_global_dofs = dof.n_dofs();
+    types::global_dof_index n_global_dofs = dof.n_dofs();
 
                                      // Actually, we compute the
                                      // inverse of the reordering
@@ -1196,9 +1196,9 @@ namespace DoFRenumbering
                                      // make sure, that each dof is
                                      // reordered only once.
     std::vector<bool> already_sorted(n_global_dofs, false);
-    std::vector<unsigned int> cell_dofs;
+    std::vector<types::global_dof_index> cell_dofs;
 
-    unsigned int global_index = 0;
+    types::global_dof_index global_index = 0;
 
     typename std::vector<typename DH::cell_iterator>::const_iterator cell;
 
@@ -1230,7 +1230,7 @@ namespace DoFRenumbering
       }
     Assert(global_index == n_global_dofs, ExcRenumberingIncomplete());
 
-    for (unsigned int i=0;i<reverse.size(); ++i)
+    for (types::global_dof_index i=0;i<reverse.size(); ++i)
       new_indices[reverse[i]] = i;
   }
 
@@ -1242,8 +1242,8 @@ namespace DoFRenumbering
     const unsigned int level,
     const typename std::vector<typename MGDoFHandler<dim>::cell_iterator>& cells)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs(level));
-    std::vector<unsigned int> reverse(dof.n_dofs(level));
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs(level));
+    std::vector<types::global_dof_index> reverse(dof.n_dofs(level));
 
     compute_cell_wise_dg(renumbering, reverse, dof, level, cells);
     dof.renumber_dofs(level, renumbering);
@@ -1257,8 +1257,8 @@ namespace DoFRenumbering
     const unsigned int level,
     const typename std::vector<typename MGDoFHandler<dim>::cell_iterator>& cells)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs(level));
-    std::vector<unsigned int> reverse(dof.n_dofs(level));
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs(level));
+    std::vector<types::global_dof_index> reverse(dof.n_dofs(level));
 
     compute_cell_wise(renumbering, reverse, dof, level, cells);
     dof.renumber_dofs(level, renumbering);
@@ -1268,8 +1268,8 @@ namespace DoFRenumbering
 
   template <int dim>
   void compute_cell_wise_dg (
-    std::vector<unsigned int>& new_order,
-    std::vector<unsigned int>& reverse,
+    std::vector<types::global_dof_index>& new_order,
+    std::vector<types::global_dof_index>& reverse,
     const MGDoFHandler<dim>& dof,
     const unsigned int level,
     const typename std::vector<typename MGDoFHandler<dim>::cell_iterator>& cells)
@@ -1295,12 +1295,12 @@ namespace DoFRenumbering
     Assert (reverse.size() == dof.n_dofs(level),
             ExcDimensionMismatch(reverse.size(), dof.n_dofs(level)));
 
-    unsigned int n_global_dofs = dof.n_dofs(level);
+    types::global_dof_index n_global_dofs = dof.n_dofs(level);
     unsigned int n_cell_dofs = dof.get_fe().n_dofs_per_cell();
 
-    std::vector<unsigned int> cell_dofs(n_cell_dofs);
+    std::vector<types::global_dof_index> cell_dofs(n_cell_dofs);
 
-    unsigned int global_index = 0;
+    types::global_dof_index global_index = 0;
 
     typename std::vector<typename MGDoFHandler<dim>::cell_iterator>::const_iterator cell;
 
@@ -1318,7 +1318,7 @@ namespace DoFRenumbering
       }
     Assert(global_index == n_global_dofs, ExcRenumberingIncomplete());
 
-    for (unsigned int i=0;i<new_order.size(); ++i)
+    for (types::global_dof_index i=0;i<new_order.size(); ++i)
       new_order[reverse[i]] = i;
   }
 
@@ -1326,8 +1326,8 @@ namespace DoFRenumbering
 
   template <int dim>
   void compute_cell_wise (
-    std::vector<unsigned int>& new_order,
-    std::vector<unsigned int>& reverse,
+    std::vector<types::global_dof_index>& new_order,
+    std::vector<types::global_dof_index>& reverse,
     const MGDoFHandler<dim>& dof,
     const unsigned int level,
     const typename std::vector<typename MGDoFHandler<dim>::cell_iterator>& cells)
@@ -1340,13 +1340,13 @@ namespace DoFRenumbering
     Assert (reverse.size() == dof.n_dofs(level),
             ExcDimensionMismatch(reverse.size(), dof.n_dofs(level)));
 
-    unsigned int n_global_dofs = dof.n_dofs(level);
+    types::global_dof_index n_global_dofs = dof.n_dofs(level);
     unsigned int n_cell_dofs = dof.get_fe().n_dofs_per_cell();
 
     std::vector<bool> already_sorted(n_global_dofs, false);
-    std::vector<unsigned int> cell_dofs(n_cell_dofs);
+    std::vector<types::global_dof_index> cell_dofs(n_cell_dofs);
 
-    unsigned int global_index = 0;
+    types::global_dof_index global_index = 0;
 
     typename std::vector<typename MGDoFHandler<dim>::cell_iterator>::const_iterator cell;
 
@@ -1368,7 +1368,7 @@ namespace DoFRenumbering
       }
     Assert(global_index == n_global_dofs, ExcRenumberingIncomplete());
 
-    for (unsigned int i=0;i<new_order.size(); ++i)
+    for (types::global_dof_index i=0;i<new_order.size(); ++i)
       new_order[reverse[i]] = i;
   }
 
@@ -1378,7 +1378,7 @@ namespace DoFRenumbering
   void
   downstream_dg (DH& dof, const Point<dim>& direction)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs());
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs());
     compute_downstream_dg(renumbering, dof, direction);
 
     dof.renumber_dofs(renumbering);
@@ -1391,8 +1391,8 @@ namespace DoFRenumbering
   downstream (DH& dof, const Point<dim>& direction,
               const bool dof_wise_renumbering)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs());
-    std::vector<unsigned int> reverse(dof.n_dofs());
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs());
+    std::vector<types::global_dof_index> reverse(dof.n_dofs());
     compute_downstream(renumbering, reverse, dof, direction,
                        dof_wise_renumbering);
 
@@ -1404,7 +1404,7 @@ namespace DoFRenumbering
   template <class DH, int dim>
   void
   compute_downstream_dg (
-    std::vector<unsigned int>& new_indices,
+    std::vector<types::global_dof_index>& new_indices,
     const DH& dof,
     const Point<dim>& direction)
   {
@@ -1418,7 +1418,7 @@ namespace DoFRenumbering
     copy (begin, end, ordered_cells.begin());
     std::sort (ordered_cells.begin(), ordered_cells.end(), comparator);
 
-    std::vector<unsigned int> reverse(new_indices.size());
+    std::vector<types::global_dof_index> reverse(new_indices.size());
     compute_cell_wise_dg(new_indices, reverse, dof, ordered_cells);
   }
 
@@ -1427,8 +1427,8 @@ namespace DoFRenumbering
   template <class DH, int dim>
   void
   compute_downstream_dg (
-    std::vector<unsigned int>& new_indices,
-    std::vector<unsigned int>& reverse,
+    std::vector<types::global_dof_index>& new_indices,
+    std::vector<types::global_dof_index>& reverse,
     const DH& dof,
     const Point<dim>& direction)
   {
@@ -1449,8 +1449,8 @@ namespace DoFRenumbering
   template <class DH, int dim>
   void
   compute_downstream (
-    std::vector<unsigned int>& new_indices,
-    std::vector<unsigned int>& reverse,
+    std::vector<types::global_dof_index>& new_indices,
+    std::vector<types::global_dof_index>& reverse,
     const DH& dof,
     const Point<dim>& direction,
     const bool dof_wise_renumbering)
@@ -1537,8 +1537,8 @@ namespace DoFRenumbering
                       const unsigned int level,
                       const Point<dim>&  direction)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs(level));
-    std::vector<unsigned int> reverse(dof.n_dofs(level));
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs(level));
+    std::vector<types::global_dof_index> reverse(dof.n_dofs(level));
     compute_downstream_dg(renumbering, reverse, dof, level, direction);
 
     dof.renumber_dofs(level, renumbering);
@@ -1552,8 +1552,8 @@ namespace DoFRenumbering
                    const Point<dim>&  direction,
                    const bool         dof_wise_renumbering)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs(level));
-    std::vector<unsigned int> reverse(dof.n_dofs(level));
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs(level));
+    std::vector<types::global_dof_index> reverse(dof.n_dofs(level));
     compute_downstream(renumbering, reverse, dof, level, direction,
                        dof_wise_renumbering);
 
@@ -1565,8 +1565,8 @@ namespace DoFRenumbering
   template <int dim>
   void
   compute_downstream_dg (
-    std::vector<unsigned int>& new_indices,
-    std::vector<unsigned int>& reverse,
+    std::vector<types::global_dof_index>& new_indices,
+    std::vector<types::global_dof_index>& reverse,
     const MGDoFHandler<dim>& dof,
     const unsigned int level,
     const Point<dim>& direction)
@@ -1590,8 +1590,8 @@ namespace DoFRenumbering
   template <int dim>
   void
   compute_downstream (
-    std::vector<unsigned int>& new_indices,
-    std::vector<unsigned int>& reverse,
+    std::vector<types::global_dof_index>& new_indices,
+    std::vector<types::global_dof_index>& reverse,
     const MGDoFHandler<dim>& dof,
     const unsigned int level,
     const Point<dim>& direction,
@@ -1705,7 +1705,7 @@ namespace DoFRenumbering
     const Point<dim>& center,
     const bool counter)
   {
-    std::vector<unsigned int> renumbering(dof.n_dofs());
+    std::vector<types::global_dof_index> renumbering(dof.n_dofs());
     compute_clockwise_dg(renumbering, dof, center, counter);
 
     dof.renumber_dofs(renumbering);
@@ -1716,7 +1716,7 @@ namespace DoFRenumbering
   template <class DH, int dim>
   void
   compute_clockwise_dg (
-    std::vector<unsigned int>& new_indices,
+    std::vector<types::global_dof_index>& new_indices,
     const DH& dof,
     const Point<dim>& center,
     const bool counter)
@@ -1731,7 +1731,7 @@ namespace DoFRenumbering
     std::copy (begin, end, ordered_cells.begin());
     std::sort (ordered_cells.begin(), ordered_cells.end(), comparator);
 
-    std::vector<unsigned int> reverse(new_indices.size());
+    std::vector<types::global_dof_index> reverse(new_indices.size());
     compute_cell_wise_dg(new_indices, reverse, dof, ordered_cells);
   }
 
@@ -1774,10 +1774,10 @@ namespace DoFRenumbering
   template <class DH>
   void
   compute_random (
-    std::vector<unsigned int>& new_indices,
+    std::vector<types::global_dof_index>& new_indices,
     const DH&                  dof_handler)
   {
-    const unsigned int n_dofs = dof_handler.n_dofs();
+    const types::global_dof_index n_dofs = dof_handler.n_dofs();
     Assert(new_indices.size() == n_dofs,
            ExcDimensionMismatch(new_indices.size(), n_dofs));
 
index dd5c1facbe1ff1ec17a95ba392fa771266070817..c16d8087ef3416f7ec08ff5e3abd643836e98915 100644 (file)
@@ -68,7 +68,7 @@ namespace DoFRenumbering
 
     template
     void
-    compute_Cuthill_McKee (std::vector<unsigned int> &,
+    compute_Cuthill_McKee (std::vector<dealii::types::global_dof_index> &,
                           const DoFHandler<deal_II_dimension> &, bool, bool);
 
     template
@@ -77,7 +77,7 @@ namespace DoFRenumbering
 
     template
     void
-    compute_king_ordering (std::vector<unsigned int> &,
+    compute_king_ordering (std::vector<dealii::types::global_dof_index> &,
                           const DoFHandler<deal_II_dimension> &, bool, bool);
 
     template
@@ -86,7 +86,7 @@ namespace DoFRenumbering
 
     template
     void
-    compute_minimum_degree (std::vector<unsigned int> &,
+    compute_minimum_degree (std::vector<dealii::types::global_dof_index> &,
                            const DoFHandler<deal_II_dimension> &, bool, bool);
 
 
@@ -96,7 +96,7 @@ namespace DoFRenumbering
 
     template
     void
-    compute_Cuthill_McKee (std::vector<unsigned int> &,
+    compute_Cuthill_McKee (std::vector<dealii::types::global_dof_index> &,
                           const hp::DoFHandler<deal_II_dimension> &, bool, bool);
 
     template
@@ -105,7 +105,7 @@ namespace DoFRenumbering
 
     template
     void
-    compute_king_ordering (std::vector<unsigned int> &,
+    compute_king_ordering (std::vector<dealii::types::global_dof_index> &,
                           const hp::DoFHandler<deal_II_dimension> &, bool, bool);
 
     template
@@ -114,7 +114,7 @@ namespace DoFRenumbering
 
     template
     void
-    compute_minimum_degree (std::vector<unsigned int> &,
+    compute_minimum_degree (std::vector<dealii::types::global_dof_index> &,
                            const hp::DoFHandler<deal_II_dimension> &, bool, bool);
     \}
     
index 816dfc283c89d9a0d4e6769c924f52d48f07d14e..41ec345622793c985e892d8d7b387d6ab340c635 100644 (file)
@@ -81,20 +81,20 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
     template void
     DoFTools::make_boundary_sparsity_pattern<DoFHandler<deal_II_dimension>,SP>
     (const DoFHandler<deal_II_dimension>& 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>,SP>
     (const hp::DoFHandler<deal_II_dimension>& 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>,SP>
     (const 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
index 053d2202e369009bcbe62a3343a40d21a9a58267..daab651e371958b5e0e2252b3869f8ba4e19e4d9 100644 (file)
@@ -411,7 +411,7 @@ void PointValueHistory<dim>
         }
     }
 
-  std::vector<unsigned int> local_dof_indices (dof_handler->get_fe ().dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dof_handler->get_fe ().dofs_per_cell);
   for (unsigned int point = 0; point < locations.size (); point++)
     {
       current_cell[point]->get_dof_indices (local_dof_indices);
index ba65336dd6bb80cfc4bb64bc6c08a200ff79ccf8..548c7dc99f7078d3e9a28271f476528533be6743 100644 (file)
@@ -759,7 +759,7 @@ namespace LaplaceSolver
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     std::vector<double> laplace_coefficients (fe_values.n_quadrature_points);
     std::vector<double> mass_coefficients (fe_values.n_quadrature_points);
@@ -1027,7 +1027,7 @@ namespace LaplaceSolver
 
     Vector<double>       cell_rhs (dofs_per_cell);
     std::vector<double>  rhs_values (n_q_points);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::active_cell_iterator
       cell = this->dof_handler.begin_active(),
@@ -2146,7 +2146,7 @@ namespace DualFunctional
                                     // shape functions at the
                                     // quadrature points:
     Vector<double> cell_rhs (dofs_per_cell);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
                                     // Finally have a variable in
                                     // which we will sum up the
index 5a4143225427a9ca97efc83d3ed13bc7f5afcf41..ac095d56898571940bffceb673c0e189419be012 100644 (file)
@@ -105,7 +105,7 @@ void SystemTest<dim>::check_numbering ()
   typename DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
-  std::vector<unsigned int>    local_dof_indices(fe.dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices(fe.dofs_per_cell);
        
   for (; cell!=endc; ++cell)
     {
index a8c1ab73824f4ca41faa13258e5f5f60dc1af281..7bc90e4d4b65d0cb57f1fbdd7d472a2bd2631fad 100644 (file)
@@ -106,7 +106,7 @@ void SystemTest<dim>::check_numbering ()
   typename DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
-  std::vector<unsigned int>    local_dof_indices(fe.dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices(fe.dofs_per_cell);
        
   for (; cell!=endc; ++cell)
     {
index f97d6958d1feb8aeac9ffbedcdf98cd4358580f0..24ec5dbeed9fd8f5c712db87c7f2d263e15f6a64 100644 (file)
@@ -53,7 +53,7 @@ void test ()
 
                                   // loop over all cells, active or
                                   // not
-  std::vector<unsigned int> local_dof_indices (fe.dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (fe.dofs_per_cell);
   for (typename DoFHandler<dim>::cell_iterator cell=dof_handler.begin();
        cell != dof_handler.end(); ++cell)
     {
index a2e5e9c41ae30f596757beedc4f9051d50d7b717..5cb596bc2012dd0e15265eeb176a855ace4fe9f3 100644 (file)
@@ -560,7 +560,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
index fb7d492c60979c6f26e4b3f65bfc8f9a695ff478..6fe5b0a17bd30a79d2b3936ed652b98d3f639715 100644 (file)
@@ -406,7 +406,7 @@ namespace LaplaceSolver
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     for (typename DoFHandler<dim>::active_cell_iterator cell=begin_cell;
         cell!=end_cell; ++cell)
@@ -529,7 +529,7 @@ namespace LaplaceSolver
 
     Vector<double>       cell_rhs (dofs_per_cell);
     std::vector<double>  rhs_values (n_q_points);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::active_cell_iterator
       cell = this->dof_handler.begin_active(),
index 8b7e7937b8a3bd7cde2e9d81d9b7b17583617e6e..e34e85bf7ff783d28d8042e9a4632230b1f2c847 100644 (file)
@@ -492,7 +492,7 @@ namespace LaplaceSolver
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     for (typename DoFHandler<dim>::active_cell_iterator cell=begin_cell;
         cell!=end_cell; ++cell)
@@ -675,7 +675,7 @@ namespace LaplaceSolver
 
     Vector<double>       cell_rhs (dofs_per_cell);
     std::vector<double>  rhs_values (n_q_points);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::active_cell_iterator
       cell = this->dof_handler.begin_active(),
@@ -1224,7 +1224,7 @@ namespace DualFunctional
     const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
 
     Vector<double> cell_rhs (dofs_per_cell);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     double total_volume = 0;
 
index 7e63a064f8cf771c90810d29141d81637b4bdfb5..6af01bdc73131321f7530608b5ea095c43da55e6 100644 (file)
@@ -196,7 +196,7 @@ void MinimizationProblem<dim>::assemble_step ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   std::vector<double>         local_solution_values (n_q_points);
   std::vector<Tensor<1,dim> > local_solution_grads (n_q_points);
index cc28e4315a14d0cc8c3743cfd82a873bf3dcbbda..27039a9b8a75e2ede098510433d97f37557923cb 100644 (file)
@@ -144,7 +144,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   typename DoFHandler<dim>::active_cell_iterator cell = mg_dof_handler.begin_active(),
                                                 endc = mg_dof_handler.end();
@@ -200,7 +200,7 @@ void LaplaceProblem<dim>::assemble_multigrid ()
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   typename MGDoFHandler<dim>::cell_iterator cell = mg_dof_handler.begin(),
                                            endc = mg_dof_handler.end();
index f294f10cf04a49f98407850d8bddeda85bb8b1d1..c1e03b92b1872b8c8a01fe81f7f25d5a1dc80431 100644 (file)
@@ -125,7 +125,7 @@ void LaplaceProblem::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   DoFHandler<2>::active_cell_iterator
     cell = dof_handler.begin_active(),
index fc8d32123cf5bc02b9b269484d4128c8a3eb87b2..9d01af819fe61dc0451b377d8349b7abc8523388 100644 (file)
@@ -183,7 +183,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   typename DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active(),
                                                 endc = dof_handler.end();
index 10ceb6704c6f3f93c9806a20230a26985979087c..2bf5a5fb1f1031f816a1d41a10ab1acfc869abd3 100644 (file)
@@ -179,7 +179,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
index ee94fecd70c0743c68b7ef06ffcfe6b79d3e8013..0edaccefc3d0c694aa75cd2b0a824bfaadf3de3b 100644 (file)
@@ -204,7 +204,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
index 295b89d62938887209ab8483fcc60eb5af69f595..758016de2dbe1c959d1c586302718a669cc46512 100644 (file)
@@ -274,7 +274,7 @@ void HelmholtzProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   
   FEValues<dim>  x_fe_values (*fe, quadrature_formula, 
                            update_values   | update_gradients |
index d8c4239c0733d639d0db7af90f3b46a8d650f494..0858ae5bcb2dbd4bc310cb661c2ebefe58f14bb2 100644 (file)
@@ -210,7 +210,7 @@ void ElasticProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   std::vector<double>     lambda_values (n_q_points);
   std::vector<double>     mu_values (n_q_points);
index 8ea9a7882cfd0520e403b311cfbf0a70c366f4f0..9ef85f2327d743b639a1357095de07af62009b47 100644 (file)
@@ -264,8 +264,8 @@ BEM<spacedim>::assemble_system()
 
     std::vector< Point<spacedim> > cell_normals_i, cell_normals_j;
 
-    std::vector<unsigned int> local_dof_indices_i (dofs_per_cell);
-    std::vector<unsigned int> local_dof_indices_j (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices_i (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices_j (dofs_per_cell);
  
 
 //     std::cout
@@ -568,7 +568,7 @@ BEM<spacedim>::solve()
    
     std::vector< Point<spacedim> > cell_normals(q_iterated.size());
     std::vector< Point<spacedim> > cell_tangentials(q_iterated.size());
-    std::vector<unsigned int> local_dof_indices (fe_q.dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (fe_q.dofs_per_cell);
 
     typename DoFHandler<spacedim-1, spacedim>::active_cell_iterator
        cell = dof_handler_q.begin_active(),
index 5ea9fee01d01498cb17bdcb6848292256c8de512..cc7391c2d5522f3e8e1fc544d4754df524a9ecb4 100644 (file)
@@ -126,7 +126,7 @@ void test(std::string filename)
   std::vector<double> shape_directional_derivative(dofs_per_cell);
   Vector<double> projected_directional_derivative(triangulation.n_cells());
 
-  std::vector<unsigned int> local_dof_indices (fe.dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (fe.dofs_per_cell);
 
   typename DoFHandler<dim, spacedim>::active_cell_iterator
       cell = dof_handler.begin_active(),
index 847276be89109601ad9acfef917ef88938a73772..d9dd81d6588e538b960f7fd9c5d759b839de8339 100644 (file)
@@ -268,7 +268,7 @@ void LaplaceProblem<Vector,Matrix,Sparsity>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   ::Vector<double>     cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   DoFHandler<2>::active_cell_iterator cell = dof_handler.begin_active(),
                                      endc = dof_handler.end();
index 306b1120ab7efb4a4b08e34650e698bb9e8031e3..47f4f7777019ed4aa7ff4cee802bb74d3e88de56 100644 (file)
@@ -169,7 +169,7 @@ void MixedElastoPlasticity<dim>::assemble_system()
   FullMatrix<double> local_matrix(dofs_per_cell, dofs_per_cell);
   Vector<double> local_rhs(dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices(dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices(dofs_per_cell);
 
 
   const FEValuesExtractors::SymmetricTensor<2> stress(0);
index 7ffb1e3432683eee0876c28dc5133f27366d3ed0..c97af1765fed728abc3d87dec6371bf32b9c2dfb 100644 (file)
@@ -149,7 +149,7 @@ void MixedElastoPlasticity<dim>::assemble_system()
        const unsigned int dofs_per_cell = fe.dofs_per_cell;
        deallog << "dofs_per_cell: " << fe.dofs_per_cell << std::endl;
 
-       std::vector<unsigned int> local_dof_indices(dofs_per_cell);
+       std::vector<types::global_dof_index> local_dof_indices(dofs_per_cell);
 
        const FEValuesExtractors::SymmetricTensor<2> stress(0);
        const FEValuesExtractors::Scalar gamma(n_stress_components);
index 73e6884de470d9f878cc0cb5b195c56654cbb801..9c8f121fa7147a23fa0efa962f6688831b0d28fc 100644 (file)
@@ -290,7 +290,7 @@ void LaplaceProblem<dim>::assemble_reference ()
   FullMatrix<double>   cell_matrix;
   Vector<double>       cell_rhs;
 
-  std::vector<unsigned int> local_dof_indices;
+  std::vector<types::global_dof_index> local_dof_indices;
   
   typename hp::DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
@@ -370,7 +370,7 @@ void LaplaceProblem<dim>::assemble_test_1 ()
   FullMatrix<double>   cell_matrix;
   Vector<double>       cell_rhs;
 
-  std::vector<unsigned int> local_dof_indices;
+  std::vector<types::global_dof_index> local_dof_indices;
   
   typename hp::DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
@@ -443,7 +443,7 @@ void LaplaceProblem<dim>::assemble_test_2 ()
   FullMatrix<double>   cell_matrix;
   Vector<double>       cell_rhs;
 
-  std::vector<unsigned int> local_dof_indices;
+  std::vector<types::global_dof_index> local_dof_indices;
   
   typename hp::DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
index e47ff6a965d5f53c7ad45bfe98ba28c86bf75852..a08b1fa383ec22a2e176139721aec6ee74d01973 100644 (file)
@@ -261,7 +261,7 @@ void AdvectionProblem<dim>::assemble_reference ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   std::vector<double>  rhs_values (n_q_points);
   
   typename DoFHandler<dim>::active_cell_iterator
@@ -348,7 +348,7 @@ void AdvectionProblem<dim>::assemble_test_1 ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   std::vector<double>  rhs_values (n_q_points);
   
   typename DoFHandler<dim>::active_cell_iterator
@@ -424,7 +424,7 @@ void AdvectionProblem<dim>::assemble_test_2 ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   std::vector<double>  rhs_values (n_q_points);
   
   typename DoFHandler<dim>::active_cell_iterator
index 1129d7852d1c2445a2ccdf0fe2bb5f5e2eba97d3..b67eb75fae8b12c29c979de2fb8b2f049f345234 100644 (file)
@@ -230,7 +230,7 @@ void AdvectionProblem<dim>::assemble_reference ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   std::vector<double>  rhs_values (n_q_points);
   
   typename DoFHandler<dim>::active_cell_iterator
@@ -312,7 +312,7 @@ void AdvectionProblem<dim>::assemble_test_1 ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   std::vector<double>  rhs_values (n_q_points);
   
   typename DoFHandler<dim>::active_cell_iterator
@@ -383,7 +383,7 @@ void AdvectionProblem<dim>::assemble_test_2 ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   std::vector<double>  rhs_values (n_q_points);
   
   typename DoFHandler<dim>::active_cell_iterator
index 10befb50701ce3049a33bee472386a8384d6d6eb..f6041b0099471f4e7521d9e8c39b2b03616a0c28 100644 (file)
@@ -175,7 +175,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
index c4c241819c95a11524f16033f10edfe8881d9564..b507cfbd1c9a60c8c11bf7ffbbf8a9d965e5deff 100644 (file)
@@ -109,7 +109,7 @@ void TestPointValueHistory<dim>::run()
         QGauss<dim> quadrature_formula(2);
         FEValues<dim> fe_values(finite_element, quadrature_formula, update_values | update_quadrature_points); // just need local_dof_indices and quadrature_points
 
-        std::vector<unsigned int> local_dof_indices(finite_element.dofs_per_cell);
+        std::vector<types::global_dof_index> local_dof_indices(finite_element.dofs_per_cell);
         std::vector<Point<dim> > dof_locations(finite_element.dofs_per_cell);
         Vector<double> cell_pole(finite_element.dofs_per_cell);
 
index 08dc27ea413e4328fa4d479fd82237b4a1c8a453..c2db6514f6b094b7eb0d52de3a2b1247e017c645 100644 (file)
@@ -53,7 +53,7 @@ void test(std::ostream& /*out*/)
      = dofh.begin_active();
 
    const unsigned int dofs_per_cell = dofh.get_fe().dofs_per_cell;
-   std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+   std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
 
       
index 8752ea34fd74f4aa9f6702528dccfd9508d71c43..a143368f0c9783fe20b9de5c08d825971ed0e729 100644 (file)
@@ -210,7 +210,7 @@ void LaplaceProblem<dim>::assemble_system ()
       FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
       Vector<double>       cell_rhs (dofs_per_cell);
 
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       cell_matrix = 0;
       cell_rhs = 0;
index 8913c9d34311135e29e9e0f1dfa24c82debcd0e9..c9720c9cfcba6084fa90b062b67bd7c418a1ebcd 100644 (file)
@@ -490,7 +490,7 @@ namespace LaplaceSolver
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     for (typename hp::DoFHandler<dim>::active_cell_iterator cell=begin_cell;
         cell!=end_cell; ++cell)
@@ -673,7 +673,7 @@ namespace LaplaceSolver
 
     Vector<double>       cell_rhs (dofs_per_cell);
     std::vector<double>  rhs_values (n_q_points);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename hp::DoFHandler<dim>::active_cell_iterator
       cell = this->dof_handler.begin_active(),
@@ -1222,7 +1222,7 @@ namespace DualFunctional
     const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
 
     Vector<double> cell_rhs (dofs_per_cell);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     double total_volume = 0;
     
index 18e501047ec4d8022f187b7ccc812095bbb6bda4..a1dfdd26cb6a23136fcd846d03aad21c61f308d9 100644 (file)
@@ -197,7 +197,7 @@ void MinimizationProblem<dim>::assemble_step ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   std::vector<double>         local_solution_values (n_q_points);
   std::vector<Tensor<1,dim> > local_solution_grads (n_q_points);
index 6d5de5c267b844a4c201365a6698ca9af02b502f..e274a9eccfb74c29e3bdc1a2294cdcbbf1a88d68 100644 (file)
@@ -84,7 +84,7 @@ void EvaluateDerivative (DoFHandler<2> *dof_handler,
     double err_l2 = 0,
       err_hdiv = 0;
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     for (; cell!=endc; ++cell)
     {
index 51e7563af24ab20ed834906e096134c6f0687e99..bd9debf789fa1e8c70a5763bb45ddb2aaccdbe96 100644 (file)
@@ -128,7 +128,7 @@ void EvaluateDerivative (DoFHandler<2> *dof_handler,
   double err_l2 = 0,
        err_hdiv = 0;
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   for (; cell!=endc; ++cell)
     {
index 516a0c8e9ed2d35cd8221889477398e1d14f2a16..a69bbb763df66b6ba1d9c815b6213533219d8c4d 100644 (file)
@@ -54,7 +54,7 @@ create_stokes_matrix_1 (const DoFHandler<dim> &dof_handler,
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
   
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
 
   QGauss<dim> quadrature (3);
@@ -127,7 +127,7 @@ create_stokes_matrix_2 (const DoFHandler<dim> &dof_handler,
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
   
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
 
   QGauss<dim> quadrature (3);
@@ -203,7 +203,7 @@ create_stokes_matrix_3 (const DoFHandler<dim> &dof_handler,
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
   
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
 
   QGauss<dim> quadrature (3);
index fdc8ba3e59537be342982bc7596b270f2bf56bb4..53e4f38ca17e77d0baebdfd5abc9ed19f094fa11 100644 (file)
@@ -57,7 +57,7 @@ create_stokes_matrix_2 (const DoFHandler<dim> &dof_handler,
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
   
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
 
   QGauss<dim> quadrature (3);
@@ -133,7 +133,7 @@ create_stokes_matrix_3 (const DoFHandler<dim> &dof_handler,
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
   
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
 
   QGauss<dim> quadrature (3);
index bb5491b50c3a7db8e98682f235afb58eabd7fe23..1994c4686c4efca7395cbe979b5907e42f046438 100644 (file)
@@ -93,7 +93,7 @@ void EvaluateNormal2 (DoFHandler<2> *dof_handler,
     DoFHandler<2>::active_cell_iterator cell = dof_handler->begin_active(),
        endc = dof_handler->end();
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     for (; cell!=endc; ++cell)
     {
@@ -199,7 +199,7 @@ void EvaluateNormal (DoFHandler<2> *dof_handler,
     DoFHandler<2>::active_cell_iterator cell = dof_handler->begin_active(),
        endc = dof_handler->end();
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     for (; cell!=endc; ++cell)
     {
index 9910b20dbbbcbe856b70d2f92e2863ebf3e905fa..7453b0601aa1963cd9703350901bd93463c08ea0 100644 (file)
@@ -144,7 +144,7 @@ namespace with_hp
     FullMatrix<double>   cell_matrix;
     Vector<double>       cell_rhs;
 
-    std::vector<unsigned int> local_dof_indices;
+    std::vector<types::global_dof_index> local_dof_indices;
 
     typename hp::DoFHandler<dim>::active_cell_iterator
       cell = dof_handler.begin_active(),
@@ -297,7 +297,7 @@ namespace without_hp
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       cell_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::active_cell_iterator
       cell = dof_handler.begin_active(),
index 5f0000a815ba86b482d97b71e7e2cef8fe53fb05..e2ee13085d2cdd54eb2e1ec7d0891c3195401327 100644 (file)
@@ -46,7 +46,7 @@ void test ()
   hp::DoFHandler<dim> dof_handler(tria);
   dof_handler.distribute_dofs(fe_collection);
 
-  std::vector<unsigned int> local_dof_indices (fe_collection[0].dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (fe_collection[0].dofs_per_cell);
   for (typename hp::DoFHandler<dim>::active_cell_iterator
          cell=dof_handler.begin_active();
        cell!=dof_handler.end(); ++cell)
index b9fc9701bde8cab007fd3e70c3fe9cf313c85b1a..d9bf4fd543553c24e0e07d387afecd3668a01eeb 100644 (file)
@@ -46,7 +46,7 @@ void test ()
   hp::DoFHandler<dim> dof_handler(tria);
   dof_handler.distribute_dofs(fe_collection);
 
-  std::vector<unsigned int> local_dof_indices (fe_collection[0].dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (fe_collection[0].dofs_per_cell);
   for (typename hp::DoFHandler<dim>::active_cell_iterator
          cell=dof_handler.begin_active();
        cell!=dof_handler.end(); ++cell)
index 7111b0fbf644fceda2ea9f76abea22f91c1bb4cc..98e4affb61ec559b94cee7758c0e8441a2016207 100644 (file)
@@ -46,7 +46,7 @@ void test ()
   hp::DoFHandler<dim> dof_handler(tria);
   dof_handler.distribute_dofs(fe_collection);
 
-  std::vector<unsigned int> local_dof_indices (fe_collection[0].dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (fe_collection[0].dofs_per_cell);
   for (typename hp::DoFHandler<dim>::active_cell_iterator
          cell=dof_handler.begin_active();
        cell!=dof_handler.end(); ++cell)
index 6a80fad6c30eedbc16722f5ebb3fc6dc31b2801b..605568932a8d2416a9d3b69b374958aeafcef2ea 100644 (file)
@@ -57,7 +57,7 @@ void test ()
   
   dof_handler.distribute_dofs(fe_collection);
 
-  std::vector<unsigned int> local_dof_indices;
+  std::vector<types::global_dof_index> local_dof_indices;
   for (typename hp::DoFHandler<dim>::active_cell_iterator
          cell=dof_handler.begin_active();
        cell!=dof_handler.end(); ++cell)
index b0d621ff2d61bb0f4aaf5ea9f993c0d3c2fcb3cb..fd58479d0e97f52b12837efcd2e40a9c591da7bc 100644 (file)
@@ -210,7 +210,7 @@ void LaplaceProblem<dim>::assemble_system ()
       FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
       Vector<double>       cell_rhs (dofs_per_cell);
 
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       cell_matrix = 0;
       cell_rhs = 0;
index 43ada8158cf0e34b8748dd7f699d33d14213363e..e40c7fea4105e16247a351342df23419f0a7d0a9 100644 (file)
@@ -212,7 +212,7 @@ void LaplaceProblem<dim>::assemble_system ()
       FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
       Vector<double>       cell_rhs (dofs_per_cell);
 
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       cell_matrix = 0;
       cell_rhs = 0;
index 813ab04cf8d7a8cdf086f45f346dae10fcb95a6a..57a240319ca4ce4f3e9b3f23ca9adfb4c018d6d5 100644 (file)
@@ -215,7 +215,7 @@ void LaplaceProblem<dim>::assemble_system ()
       FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
       Vector<double>       cell_rhs (dofs_per_cell);
 
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       cell_matrix = 0;
       cell_rhs = 0;
index c6abb387db7e95442e621b6f1a8e34650f199e2a..80e5f2bba3003cc2c757b794071a9fe10497b31f 100644 (file)
@@ -218,7 +218,7 @@ void LaplaceProblem<dim>::assemble_system ()
       FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
       Vector<double>       cell_rhs (dofs_per_cell);
 
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       cell_matrix = 0;
       cell_rhs = 0;
index 6fa4232dd00c6e24aa485cf766840748a2ae35e1..05694eb8e0a1757bef1958a18be46b8a30ad16d6 100644 (file)
@@ -56,7 +56,7 @@ void test ()
   
   dof_handler.distribute_dofs(fe_collection);
 
-  std::vector<unsigned int> local_dof_indices;
+  std::vector<types::global_dof_index> local_dof_indices;
   for (typename hp::DoFHandler<dim>::active_cell_iterator
          cell=dof_handler.begin_active();
        cell!=dof_handler.end(); ++cell)
index 42ad8ba30cfbf568b8a7172f457c9fcb5ea82c9c..b17dafbb3326fbf5d31e559197051977ee2b9296 100644 (file)
@@ -406,7 +406,7 @@ namespace LaplaceSolver
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     for (typename hp::DoFHandler<dim>::active_cell_iterator cell=begin_cell;
         cell!=end_cell; ++cell)
@@ -529,7 +529,7 @@ namespace LaplaceSolver
 
     Vector<double>       cell_rhs (dofs_per_cell);
     std::vector<double>  rhs_values (n_q_points);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename hp::DoFHandler<dim>::active_cell_iterator
       cell = this->dof_handler.begin_active(),
index aa97cc8a8df0e0746c4193a0930d6d690030b6cd..a68ce3333d3bca01a9a1752acca3977d49085197 100644 (file)
@@ -125,7 +125,7 @@ void LaplaceProblem::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   hp::DoFHandler<2>::active_cell_iterator
     cell = dof_handler.begin_active(),
index 5cb2162112303116950326b76d4a0b02b18a669b..9d20dc51d90c33d073e38f0a09af3e6f4be15f29 100644 (file)
@@ -159,7 +159,7 @@ void LaplaceProblem::assemble_system ()
   FullMatrix<double>   cell_matrix (max_dofs_per_cell, max_dofs_per_cell);
   Vector<double>       cell_rhs (max_dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (max_dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (max_dofs_per_cell);
 
   hp::DoFHandler<2>::active_cell_iterator
     cell = dof_handler.begin_active(),
index 140edba89bd3c407e49763cfc05848326f62fc83..70a9bf905e92f53ec775bae9d4fa3653f59cabf9 100644 (file)
@@ -156,7 +156,7 @@ void LaplaceProblem::assemble_system ()
   FullMatrix<double>   cell_matrix (max_dofs_per_cell, max_dofs_per_cell);
   Vector<double>       cell_rhs (max_dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (max_dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (max_dofs_per_cell);
 
   hp::DoFHandler<2>::active_cell_iterator
     cell = dof_handler.begin_active(),
index dcc457da82ceb4c4a0348ed48abe1e5016d0edfd..2817a37fc13697375e3b2a449795edd711df8a7d 100644 (file)
@@ -158,7 +158,7 @@ void LaplaceProblem::assemble_system ()
   FullMatrix<double>   cell_matrix (max_dofs_per_cell, max_dofs_per_cell);
   Vector<double>       cell_rhs (max_dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (max_dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (max_dofs_per_cell);
 
   hp::DoFHandler<2>::active_cell_iterator
     cell = dof_handler.begin_active(),
index ba1809a4e9f838f0f733e4e829642024a3ed508d..d85f125e39e54e3c8d20b26b020add13f6783028 100644 (file)
@@ -182,7 +182,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   typename hp::DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active(),
                                                 endc = dof_handler.end();
index 145f1538ef2324338016076c8647e850ef0f9016..90ab7d526dd2e5355de284ec441eca293b267ae0 100644 (file)
@@ -178,7 +178,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
index 397d5a597707e9ffa09dc774595ae65db91d69e9..f03efd6495e33dd80a3547de869f28b2d6e9ed75 100644 (file)
@@ -203,7 +203,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
index 0aebd7b33f2a3501325ac3410cf4b8ecff70f4b4..abd63a8ce9230db042692a92d52a1393bfb2e7b7 100644 (file)
@@ -273,7 +273,7 @@ void HelmholtzProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   
   hp::FEValues<dim>  x_fe_values (*fe, quadrature_formula, 
                            update_values   | update_gradients |
index 7786eb3c58b5f894da08c58ac0912af34f838a7e..4afbe8fcbddc53a389cdc2004a968c4dd2bbbbd1 100644 (file)
@@ -209,7 +209,7 @@ void ElasticProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   std::vector<double>     lambda_values (n_q_points);
   std::vector<double>     mu_values (n_q_points);
index d7ba97de59e494da0910b9838a02def08745a3c0..77f0f87d65a2c5dc52f7c31a584955c88e25a488 100644 (file)
@@ -62,7 +62,7 @@ void test()
      = dofh.begin_active();
 
    const unsigned int dofs_per_cell = dofh.get_fe().dofs_per_cell;
-   std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+   std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
 
    if (myid==0)
index e0899ca4c1db183c60cbc4293ae469210fa173ac..59c5b11cfbf53387ed0990697782c76677e7aa07 100644 (file)
@@ -94,7 +94,7 @@ void test()
        = dofh.begin_active();
 
       const unsigned int dofs_per_cell = dofh.get_fe().dofs_per_cell;
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       for (; cell != dofh.end(); ++cell)
        if (cell->is_ghost())
index f83005e7d3dd04a995dc91e2b65b9f3b2c53d440..6c11b6add35a790500da650c2a07d6be261b5402 100644 (file)
@@ -98,7 +98,7 @@ void test()
        = dofh.begin_active();
 
        const unsigned int dofs_per_cell = dofh.get_fe().dofs_per_cell;
-       std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+       std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
        for (; cell != dofh.end(); ++cell)
         if (!cell->is_artificial())
index c106b4ccc7e377c26a653120652627b76be0b19c..bd22a8c933aa5b3ed7ca3aabda1d01629f8a136b 100644 (file)
@@ -81,7 +81,7 @@ void test()
       if (myid==0)
        {
 
-         std::vector<unsigned int> local_dof_indices;
+         std::vector<types::global_dof_index> local_dof_indices;
        typename DoFHandler<dim>::active_cell_iterator
          cell, endc = dofh.end();
 
index b6c07eae1bb144a6afc1bd0e6192550f0fd04834..fe3f576806ad4d5756eb808b93398d6730085780 100644 (file)
@@ -90,7 +90,7 @@ void test()
     if (myid==0)
       {
 
-       std::vector<unsigned int> local_dof_indices;
+       std::vector<types::global_dof_index> local_dof_indices;
        typename DoFHandler<dim>::active_cell_iterator
          cell, endc = dofh.end();
 
index e96ea4f0afb96ed22d17286719b5cbd19b2d78e6..3fef43319948579e4e70e18dc90f016c456740c6 100644 (file)
@@ -53,7 +53,7 @@ void check()
   typename MGDoFHandler<dim>::cell_iterator
     cell = mgdof.begin(),
     endc = mgdof.end();
-  std::vector<unsigned int> local_dof_indices (fe.dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (fe.dofs_per_cell);
   std::vector<unsigned int> mg_dof_indices (fe.dofs_per_cell);
   for (; cell!=endc; ++cell)
     {
index a58f665f6f1c608fa84aa8e9a23c5e7d73c4dcc9..733d3d046796d3cda22826c40f7e31e06bbb7da2 100644 (file)
@@ -428,7 +428,7 @@ void LaplaceProblem<dim>::assemble_system ()
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
@@ -499,7 +499,7 @@ void LaplaceProblem<dim>::assemble_multigrid ()
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values (n_q_points);
index 2015ceb0be7cf05b156b403715c24e9f0226955c..4f919f480b5aa77c317e9866bacc087b2613fdfc 100644 (file)
@@ -54,7 +54,7 @@ void assemble_laplace (MATRIX &B, VECTOR &bb, DoFHandler<dim> &dof_handler, Fini
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
   
-  std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
   
   typename DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),

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.