]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Make a few things compile.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 9 Feb 2013 05:15:53 +0000 (05:15 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 9 Feb 2013 05:15:53 +0000 (05:15 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28294 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/dofs/dof_accessor.templates.h
deal.II/include/deal.II/dofs/dof_handler.h
deal.II/include/deal.II/hp/dof_handler.h

index 6bf22668e1ec310c1b478a0d9d57f90506a026cf..6e836a3204032a6f8d00b8eebc23b6ff74dff9b6 100644 (file)
@@ -2681,7 +2681,7 @@ namespace internal
                            dofs_per_line   = accessor.get_fe().dofs_per_line,
                            dofs_per_cell   = accessor.get_fe().dofs_per_cell;
 
-        Assert (dof_indices.size() == dofs_per_cell,
+        Assert (local_dof_indices.size() == dofs_per_cell,
                 ExcInternalError());
 
         unsigned int index = 0;
@@ -2689,9 +2689,9 @@ namespace internal
         for (unsigned int vertex=0; vertex<2; ++vertex)
           for (unsigned int d=0; d<dofs_per_vertex; ++d, ++index)
             accessor.set_vertex_dof_index(vertex,d,
-                                          dof_indices[index]);
+                                          local_dof_indices[index]);
         for (unsigned int d=0; d<dofs_per_line; ++d, ++index)
-          accessor.dof_index(d, dof_indices[index]);
+          accessor.dof_index(d, local_dof_indices[index]);
 
         Assert (index == dofs_per_cell,
                 ExcInternalError());
@@ -2750,7 +2750,7 @@ namespace internal
                            dofs_per_hex    = accessor.get_fe().dofs_per_hex,
                            dofs_per_cell   = accessor.get_fe().dofs_per_cell;
 
-        Assert (dof_indices.size() == dofs_per_cell,
+        Assert (local_dof_indices.size() == dofs_per_cell,
                 ExcInternalError());
 
         unsigned int index = 0;
@@ -2758,7 +2758,7 @@ namespace internal
         for (unsigned int vertex=0; vertex<8; ++vertex)
           for (unsigned int d=0; d<dofs_per_vertex; ++d, ++index)
             accessor.set_vertex_dof_index(vertex,d,
-                                          dof_indices[index]);
+                                          local_dof_indices[index]);
         // now copy dof numbers into the line. for
         // lines with the wrong orientation, we have
         // already made sure that we're ok by picking
@@ -2775,7 +2775,7 @@ namespace internal
             accessor.line(line)->set_dof_index(accessor.dof_handler->get_fe().
                                                adjust_line_dof_index_for_line_orientation(d,
                                                    accessor.line_orientation(line)),
-                                               dof_indices[index]);
+                                               local_dof_indices[index]);
         // now copy dof numbers into the face. for
         // faces with the wrong orientation, we
         // have already made sure that we're ok by
@@ -2796,9 +2796,9 @@ namespace internal
                                                    accessor.face_orientation(quad),
                                                    accessor.face_flip(quad),
                                                    accessor.face_rotation(quad)),
-                                               dof_indices[index]);
+                                               local_dof_indices[index]);
         for (unsigned int d=0; d<dofs_per_hex; ++d, ++index)
-          accessor.set_dof_index(d, dof_indices[index]);
+          accessor.set_dof_index(d, local_dof_indices[index]);
 
         Assert (index == dofs_per_cell,
                 ExcInternalError());
index 6fce801585f9c7f286e47341fd033e1375ae7ae5..747665d0dce223165165cf81aa7be7f1a32963ca 100644 (file)
@@ -311,8 +311,6 @@ public:
    */
   virtual void distribute_dofs (const FiniteElement<dim,spacedim> &fe);
 
-  virtual void distribute_mg_dofs (const FiniteElement<dim, spacedim> &fe, const types::global_dof_index offset = 0);
-
   /**
    * Distribute multigrid degrees of freedom similar
    * to distribute_dofs() but on each level.
index 008159b3918dc12e3fd934cfec1a72d200f03998..f4136f5c43a63a2a948ba20d82170223c39125f1 100644 (file)
@@ -378,7 +378,7 @@ namespace hp
      * DoFs which are constrained by
      * hanging nodes, see @ref constraints.
      */
-   types::global_dof_index  n_dofs () const;
+   types::global_dof_index n_dofs () const;
 
     /**
     * The number of multilevel
@@ -389,7 +389,7 @@ namespace hp
     * numbers::invalid_unsigned
     * int independent of its argument.
     */
-    types::global_dof_index int n_dofs(const unsigned int level) const;
+    types::global_dof_index n_dofs(const unsigned int level) const;
 
     /**
      * Return the number of degrees of freedom
@@ -912,7 +912,7 @@ namespace hp
 
   template <int dim, int spacedim>
   inline
-  unsigned int
+  types::global_dof_index
   DoFHandler<dim,spacedim>::n_dofs (const unsigned int) const
   {
     return numbers::invalid_unsigned_int;
@@ -920,7 +920,7 @@ namespace hp
 
 
   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;
@@ -936,7 +936,7 @@ namespace hp
 
 
   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;

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.