]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Icc7 wants to see many more this-> pointers for its two-stage name lookup scheme.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 2 Dec 2002 20:23:21 +0000 (20:23 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 2 Dec 2002 20:23:21 +0000 (20:23 +0000)
git-svn-id: https://svn.dealii.org/trunk@6799 0785d39b-7218-0410-832d-ea1e28bc413d

13 files changed:
deal.II/base/source/auto_derivative_function.cc
deal.II/deal.II/include/fe/fe_base.h
deal.II/deal.II/include/multigrid/mg_smoother.templates.h
deal.II/deal.II/source/dofs/dof_accessor.cc
deal.II/deal.II/source/fe/fe_dgp.cc
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/deal.II/source/fe/fe_nedelec.cc
deal.II/deal.II/source/fe/fe_q.cc
deal.II/deal.II/source/fe/fe_system.cc
deal.II/deal.II/source/fe/mapping_q.cc
deal.II/deal.II/source/grid/grid_reordering.cc
deal.II/deal.II/source/multigrid/mg_dof_accessor.cc
deal.II/deal.II/source/numerics/time_dependent.cc

index 25aec586a21a14c0bc3f49da260485773e728f2d..a143fc16ae676d95d60ee56a5079859938c8eb4c 100644 (file)
@@ -77,7 +77,7 @@ AutoDerivativeFunction<dim>::gradient (const Point<dim>   &p,
        for (unsigned int i=0; i<dim; ++i)
          {
            q1=p-ht[i];
-           grad[i]=(value(p, comp)-value(q1, comp))/h;
+           grad[i]=(this->value(p, comp)-this->value(q1, comp))/h;
          }
        break;
       }
@@ -88,7 +88,7 @@ AutoDerivativeFunction<dim>::gradient (const Point<dim>   &p,
          {
            q1=p+ht[i];
            q2=p-ht[i];
-           grad[i]=(value(q1, comp)-value(q2, comp))/(2*h);
+           grad[i]=(this->value(q1, comp)-this->value(q2, comp))/(2*h);
          }
        break;
       }
@@ -101,10 +101,10 @@ AutoDerivativeFunction<dim>::gradient (const Point<dim>   &p,
            q1=q2+ht[i];
            q3=p-ht[i];
            q4=q3-ht[i];
-           grad[i]=(-  value(q1, comp)
-                    +8*value(q2, comp)
-                    -8*value(q3, comp)
-                    +  value(q4, comp))/(12*h);
+           grad[i]=(-  this->value(q1, comp)
+                    +8*this->value(q2, comp)
+                    -8*this->value(q3, comp)
+                    +  this->value(q4, comp))/(12*h);
            
          }
        break;
@@ -133,8 +133,8 @@ void AutoDerivativeFunction<dim>::vector_gradient (const Point<dim>       &p,
        for (unsigned int i=0; i<dim; ++i)
          {
            q1=p-ht[i];
-           vector_value(p, v);
-           vector_value(q1, v1);
+           this->vector_value(p, v);
+           this->vector_value(q1, v1);
            
            for (unsigned int comp=0; comp<this->n_components; ++comp)
              gradients[comp][i]=(v(comp)-v1(comp))*h_inv;
@@ -150,8 +150,8 @@ void AutoDerivativeFunction<dim>::vector_gradient (const Point<dim>       &p,
          {
            q1=p+ht[i];
            q2=p-ht[i];
-           vector_value(q1, v1);
-           vector_value(q2, v2);
+           this->vector_value(q1, v1);
+           this->vector_value(q2, v2);
            
            for (unsigned int comp=0; comp<this->n_components; ++comp)
              gradients[comp][i]=(v1(comp)-v2(comp))*h_inv_2;
@@ -171,10 +171,10 @@ void AutoDerivativeFunction<dim>::vector_gradient (const Point<dim>       &p,
            q1=q2+ht[i];
            q3=p-ht[i];
            q4=q3-ht[i];
-           vector_value(q1, v1);
-           vector_value(q2, v2);
-           vector_value(q3, v3);
-           vector_value(q4, v4);
+           this->vector_value(q1, v1);
+           this->vector_value(q2, v2);
+           this->vector_value(q3, v3);
+           this->vector_value(q4, v4);
            
            for (unsigned int comp=0; comp<this->n_components; ++comp)
              gradients[comp][i]=(-v1(comp)+8*v2(comp)-8*v3(comp)+v4(comp))*h_inv_12;
@@ -204,7 +204,7 @@ void AutoDerivativeFunction<dim>::gradient_list (const std::vector<Point<dim> >
          for (unsigned int i=0; i<dim; ++i)
            {
              q1=points[p]-ht[i];
-             gradients[p][i]=(value(points[p], comp)-value(q1, comp))/h;
+             gradients[p][i]=(this->value(points[p], comp)-this->value(q1, comp))/h;
            }
        break;
       }
@@ -216,7 +216,7 @@ void AutoDerivativeFunction<dim>::gradient_list (const std::vector<Point<dim> >
            {
              q1=points[p]+ht[i];
              q2=points[p]-ht[i];
-             gradients[p][i]=(value(q1, comp)-value(q2, comp))/(2*h);
+             gradients[p][i]=(this->value(q1, comp)-this->value(q2, comp))/(2*h);
            }
        break;
       }
@@ -230,10 +230,10 @@ void AutoDerivativeFunction<dim>::gradient_list (const std::vector<Point<dim> >
              q1=q2+ht[i];
              q3=points[p]-ht[i];
              q4=q3-ht[i];
-             gradients[p][i]=(-  value(q1, comp)
-                              +8*value(q2, comp)
-                              -8*value(q3, comp)
-                              +  value(q4, comp))/(12*h);
+             gradients[p][i]=(-  this->value(q1, comp)
+                              +8*this->value(q2, comp)
+                              -8*this->value(q3, comp)
+                              +  this->value(q4, comp))/(12*h);
            }
        break;
       }
@@ -266,7 +266,7 @@ vector_gradient_list (const std::vector<Point<dim> >            &points,
            {
              q1=points[p]-ht[i];
              for (unsigned int comp=0; comp<this->n_components; ++comp)
-               gradients[p][comp][i]=(value(points[p], comp)-value(q1, comp))/h;
+               gradients[p][comp][i]=(this->value(points[p], comp)-this->value(q1, comp))/h;
          }
        break;
       }
@@ -279,7 +279,7 @@ vector_gradient_list (const std::vector<Point<dim> >            &points,
              q1=points[p]+ht[i];
              q2=points[p]-ht[i];
              for (unsigned int comp=0; comp<this->n_components; ++comp)
-               gradients[p][comp][i]=(value(q1, comp)-value(q2, comp))/(2*h);
+               gradients[p][comp][i]=(this->value(q1, comp)-this->value(q2, comp))/(2*h);
            }
        break;
       }
@@ -294,10 +294,10 @@ vector_gradient_list (const std::vector<Point<dim> >            &points,
              q3=points[p]-ht[i];
              q4=q3-ht[i];
              for (unsigned int comp=0; comp<this->n_components; ++comp)
-               gradients[p][comp][i]=(-  value(q1, comp)
-                                      +8*value(q2, comp)
-                                      -8*value(q3, comp)
-                                      +  value(q4, comp))/(12*h);
+               gradients[p][comp][i]=(-  this->value(q1, comp)
+                                      +8*this->value(q2, comp)
+                                      -8*this->value(q3, comp)
+                                      +  this->value(q4, comp))/(12*h);
            }
        break;
       }
index 6d5f4db352c43932e1073878d2239e09c837d42b..9e75f5d666592225296407f43ed92157a77b2ba3 100644 (file)
@@ -1552,6 +1552,14 @@ class FiniteElementBase : public Subscriptor,
                                      * not already initialized.
                                      */
     template <int dim_> friend class FESystem;
+
+                                     /**
+                                      * Make the inner class a
+                                      * friend. This is not strictly
+                                      * necessary, but the Intel
+                                      * compiler seems to want this.
+                                      */
+    friend class InternalDataBase;
 };
 
 
index bc6536aa17701739c31aadd52822ad4d107a5d3d..81ebfd1a505b3e5178b528c282ba2c2cc18de990 100644 (file)
@@ -45,9 +45,9 @@ MGSmootherRelaxation<MATRIX, VECTOR>
   for(unsigned i=0; i<this->get_steps(); ++i)
     {
       (*matrix)[level].residual(h1, u, rhs);
-      set_zero_interior_boundary(level,h1);
+      this->set_zero_interior_boundary(level,h1);
       ((*matrix)[level].*relaxation)(h2,h1,omega);
-      set_zero_interior_boundary(level,h2);
+      this->set_zero_interior_boundary(level,h2);
       u.add(h2);
     }
 }
index 5f0400da5d65e57673cf32c0c1be798bb2de5370..b591d4e8789bd74e072f2666af2fc705cfa5bc54 100644 (file)
@@ -655,7 +655,7 @@ DoFCellAccessor<dim>::get_interpolated_dof_values (const InputVector &values,
   if (!this->has_children())
                                     // if this cell has no children: simply
                                     // return the exact values on this cell
-    get_dof_values (values, interpolated_values);
+    this->get_dof_values (values, interpolated_values);
   else
                                     // otherwise clobber them from the children
     {
@@ -759,7 +759,7 @@ DoFCellAccessor<dim>::set_dof_values_by_interpolation (const Vector<number> &loc
   if (!this->has_children())
                                      // if this cell has no children: simply
                                     // set the values on this cell
-    set_dof_values (local_values, values);
+    this->set_dof_values (local_values, values);
   else
                                     // otherwise distribute them to the children
     {
index 71d8111e1696a82e3d1f536dda0ef3c67fd475fd..aec8650d6c7ea2348e0a040a153cfaf7d0574fcd 100644 (file)
@@ -318,7 +318,7 @@ FE_DGP<dim>::fill_fe_values (const Mapping<dim>                   &mapping,
     }
   
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
 }
 
 
@@ -365,7 +365,7 @@ FE_DGP<dim>::fill_fe_face_values (const Mapping<dim>                   &mapping,
     }
 
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 
@@ -414,7 +414,7 @@ FE_DGP<dim>::fill_fe_subface_values (const Mapping<dim>                   &mappi
     }
   
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 
index 08c8ae502768830a550d14f868b4c4bf074cba35..485604393d4c6c48cf249d49af712e5359bcb7ad 100644 (file)
@@ -533,7 +533,7 @@ FE_DGQ<dim>::fill_fe_values (const Mapping<dim>                   &mapping,
     }
   
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
 }
 
 
@@ -580,7 +580,7 @@ FE_DGQ<dim>::fill_fe_face_values (const Mapping<dim>                   &mapping,
     }
 
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 
@@ -629,7 +629,7 @@ FE_DGQ<dim>::fill_fe_subface_values (const Mapping<dim>                   &mappi
     }
   
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 
index 7d2e9e846be1111094cb509234edf2df29cd1abe..14e7257f2cb8e7c76c08c4eb4bbdb4afa4fb75db 100644 (file)
@@ -937,7 +937,7 @@ FE_Nedelec<dim>::fill_fe_values (const Mapping<dim>                   &mapping,
     }
 
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
 };
 
 
@@ -988,7 +988,7 @@ FE_Nedelec<dim>::fill_fe_face_values (const Mapping<dim>                   &mapp
       
       std::vector<Tensor<1,dim> > shape_values (n_q_points);
 
-      Assert (data.shape_values.n_rows() == dofs_per_cell * dim,
+      Assert (data.shape_values.n_rows() == this->dofs_per_cell * dim,
              ExcInternalError());
       Assert (data.shape_values.n_cols() == n_q_points,
              ExcInternalError());
@@ -1078,7 +1078,7 @@ FE_Nedelec<dim>::fill_fe_face_values (const Mapping<dim>                   &mapp
     }
 
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 
@@ -1221,7 +1221,7 @@ FE_Nedelec<dim>::fill_fe_subface_values (const Mapping<dim>                   &m
     }
 
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 };
 
 
index 7a05b21fee33ee341197cf72674d35f362204854..3a57551c163794f6f7bbcea47abdc1949560abd7 100644 (file)
@@ -1198,7 +1198,7 @@ FE_Q<dim>::fill_fe_values (const Mapping<dim>                   &mapping,
     }
 
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
 }
 
 
@@ -1245,7 +1245,7 @@ FE_Q<dim>::fill_fe_face_values (const Mapping<dim>                   &mapping,
     }
 
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 
@@ -1294,7 +1294,7 @@ FE_Q<dim>::fill_fe_subface_values (const Mapping<dim>                   &mapping
     }
   
   if (flags & update_second_derivatives)
-    compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+    this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 
index b2272e83405263c35562f3e52f80ef06568f9765..29d507738557bbaf14a2116b47b15fdeed9bf2be 100644 (file)
@@ -860,7 +860,7 @@ compute_fill (const Mapping<dim>                   &mapping,
                 ? face_no * n_q_points
                 :(face_no * GeometryInfo<dim>::subfaces_per_face
                   + sub_no) * n_q_points;
-      compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
+      this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
     }
 }
 
index f90805632ecaf48ce0b711a35d45822f142625ca..1318982481318574e0fc4db53ffc17f1284f16d1 100644 (file)
@@ -210,11 +210,11 @@ MappingQ<dim>::get_data (const UpdateFlags update_flags,
                         const Quadrature<dim> &quadrature) const
 {
   InternalData *data = new InternalData(n_shape_functions);
-  compute_data (update_flags, quadrature,
-               quadrature.n_quadrature_points, *data);
+  this->compute_data (update_flags, quadrature,
+                      quadrature.n_quadrature_points, *data);
   if (!use_mapping_q_on_all_cells)
-    compute_data (update_flags, quadrature,
-                 quadrature.n_quadrature_points, data->mapping_q1_data);
+    this->compute_data (update_flags, quadrature,
+                        quadrature.n_quadrature_points, data->mapping_q1_data);
   return data;
 }
 
@@ -227,12 +227,12 @@ MappingQ<dim>::get_face_data (const UpdateFlags update_flags,
 {
   InternalData *data = new InternalData(n_shape_functions);
   Quadrature<dim> q (QProjector<dim>::project_to_all_faces(quadrature));
-  compute_face_data (update_flags, q,
-                    quadrature.n_quadrature_points, *data);
+  this->compute_face_data (update_flags, q,
+                           quadrature.n_quadrature_points, *data);
   if (!use_mapping_q_on_all_cells)
-    compute_face_data (update_flags, q,
-                      quadrature.n_quadrature_points,
-                      data->mapping_q1_data);
+    this->compute_face_data (update_flags, q,
+                             quadrature.n_quadrature_points,
+                             data->mapping_q1_data);
   return data;
 }
 
@@ -245,12 +245,12 @@ MappingQ<dim>::get_subface_data (const UpdateFlags update_flags,
 {
   InternalData *data = new InternalData(n_shape_functions);
   Quadrature<dim> q (QProjector<dim>::project_to_all_subfaces(quadrature));
-  compute_face_data (update_flags, q,
-                    quadrature.n_quadrature_points, *data);
+  this->compute_face_data (update_flags, q,
+                           quadrature.n_quadrature_points, *data);
   if (!use_mapping_q_on_all_cells)
-    compute_face_data (update_flags, q,
-                      quadrature.n_quadrature_points,
-                      data->mapping_q1_data);
+    this->compute_face_data (update_flags, q,
+                             quadrature.n_quadrature_points,
+                             data->mapping_q1_data);
   return data;
 }
 
@@ -339,11 +339,11 @@ MappingQ<dim>::fill_fe_face_values (const typename DoFHandler<dim>::cell_iterato
   else
     p_data=&data;
 
-  compute_fill_face (cell, face_no, false,
-                    npts, offset, q.get_weights(),
-                    *p_data,
-                    quadrature_points, JxW_values,
-                    exterior_forms, normal_vectors);
+  this->compute_fill_face (cell, face_no, false,
+                           npts, offset, q.get_weights(),
+                           *p_data,
+                           quadrature_points, JxW_values,
+                           exterior_forms, normal_vectors);
 }
 
 
@@ -395,11 +395,11 @@ MappingQ<dim>::fill_fe_subface_values (const typename DoFHandler<dim>::cell_iter
   else
     p_data=&data;
 
-  compute_fill_face (cell, face_no, true,
-                    npts, offset, q.get_weights(),
-                    *p_data,
-                    quadrature_points, JxW_values,
-                    exterior_forms, normal_vectors);
+  this->compute_fill_face (cell, face_no, true,
+                           npts, offset, q.get_weights(),
+                           *p_data,
+                           quadrature_points, JxW_values,
+                           exterior_forms, normal_vectors);
 }
 
 
@@ -570,7 +570,7 @@ MappingQ<dim>::compute_laplace_vector(Table<2,double> &lvs) const
   
   InternalData quadrature_data(n_shape_functions);
   quadrature_data.shape_derivatives.resize(n_shape_functions * n_q_points);
-  compute_shapes(quadrature.get_points(), quadrature_data);
+  this->compute_shapes(quadrature.get_points(), quadrature_data);
   
                                   // Compute the stiffness matrix of
                                   // the inner dofs
@@ -1210,7 +1210,7 @@ Point<dim> MappingQ<dim>::transform_unit_to_real_cell (
 
   compute_mapping_support_points(cell, p_data->mapping_support_points);
   
-  const Point<dim> q=transform_unit_to_real_cell_internal(*p_data);
+  const Point<dim> q=this->transform_unit_to_real_cell_internal(*p_data);
   delete mdata;
   return q;
 }
@@ -1240,7 +1240,7 @@ Point<dim> MappingQ<dim>::transform_real_to_unit_cell (
       std::vector<Point<dim> > &points=mdata->mapping_support_points;
       compute_mapping_support_points(cell, points);
 
-      transform_real_to_unit_cell_internal(cell, p, *mdata, p_unit);
+      this->transform_real_to_unit_cell_internal(cell, p, *mdata, p_unit);
   
       delete mdata;
     }
index 125ad70f67140b3bfbc1729df9a65f88b20d2594..4eefed489bbbb2c4e42dd83134a0c6e5364ce39f 100644 (file)
@@ -114,10 +114,10 @@ GridReordering<2>::Cell::insert_faces (std::map<Face,FaceData> &global_faces)
                                   // defined by the order of vertices
                                   // in the cell object
   Face new_faces[GeometryInfo<dim>::faces_per_cell]
-    = { { { vertices[0], vertices[1] } },
-        { { vertices[1], vertices[2] } },
-       { { vertices[3], vertices[2] } },
-       { { vertices[0], vertices[3] } } };
+    = { { { this->vertices[0], this->vertices[1] } },
+        { { this->vertices[1], this->vertices[2] } },
+       { { this->vertices[3], this->vertices[2] } },
+       { { this->vertices[0], this->vertices[3] } } };
 
                                   // then insert them into the global
                                   // list and store iterators to
@@ -239,25 +239,31 @@ GridReordering<3>::Cell::insert_faces (std::map<Face,FaceData> &global_faces)
                                   // reversed here compared to the
                                   // Cell class, for simplicity
   const Face new_faces_tmp[GeometryInfo<dim>::faces_per_cell]
-    = { { { vertices[0], vertices[1], vertices[2], vertices[3] } },
-       { { vertices[4], vertices[5], vertices[6], vertices[7] } },
-       { { vertices[0], vertices[1], vertices[5], vertices[4] } },
-       { { vertices[1], vertices[5], vertices[6], vertices[2] } },
-       { { vertices[3], vertices[2], vertices[6], vertices[7] } },
-       { { vertices[0], vertices[4], vertices[7], vertices[3] } } };
+    = { { { this->vertices[0], this->vertices[1],
+            this->vertices[2], this->vertices[3] } },
+       { { this->vertices[4], this->vertices[5],
+            this->vertices[6], this->vertices[7] } },
+       { { this->vertices[0], this->vertices[1],
+            this->vertices[5], this->vertices[4] } },
+       { { this->vertices[1], this->vertices[5],
+            this->vertices[6], this->vertices[2] } },
+       { { this->vertices[3], this->vertices[2],
+            this->vertices[6], this->vertices[7] } },
+       { { this->vertices[0], this->vertices[4],
+            this->vertices[7], this->vertices[3] } } };
   Face new_faces[GeometryInfo<dim>::faces_per_cell][GridReorderingInfo<dim>::rotational_states_of_faces]
     = { { new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
-           new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
-      { new_faces_tmp[1], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
+          new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
+        { new_faces_tmp[1], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
          new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
        { new_faces_tmp[2], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
-           new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
-         { new_faces_tmp[3], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
-             new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
-           { new_faces_tmp[4], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
-               new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
-             { new_faces_tmp[5], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
-                 new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }};
+          new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
+        { new_faces_tmp[3], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
+          new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
+        { new_faces_tmp[4], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
+          new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] },
+        { new_faces_tmp[5], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0],
+          new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }};
 
                                   // first do the faces in their
                                   // usual direction
@@ -446,7 +452,7 @@ GridReordering<3>::Cell::insert_faces (std::map<Face,FaceData> &global_faces)
                                           // cell we are working on
          CellData<dim> standard_cell;
          for (unsigned int v=0; v<GeometryInfo<dim>::vertices_per_cell; ++v)
-           standard_cell.vertices[v] = vertices[v];
+           standard_cell.vertices[v] = this->vertices[v];
 
                                           // then rotate it the given
                                           // number of times
index e68364210f7117581e72b0038aec6be6d3e50a2a..7c18a9f7c340caf2cddd22929e4e77a6bfdcf6b2 100644 (file)
@@ -184,7 +184,7 @@ void
 MGDoFObjectAccessor<1, dim>::copy_from (const MGDoFObjectAccessor<1, dim> &a)
 {
   DoFObjectAccessor<1, dim>::copy_from (a);
-  set_mg_dof_handler (a.mg_dof_handler);
+  this->set_mg_dof_handler (a.mg_dof_handler);
 };
 
 
@@ -366,7 +366,7 @@ void
 MGDoFObjectAccessor<2, dim>::copy_from (const MGDoFObjectAccessor<2, dim> &a)
 {
   DoFObjectAccessor<2, dim>::copy_from (a);
-  set_mg_dof_handler (a.mg_dof_handler);
+  this->set_mg_dof_handler (a.mg_dof_handler);
 };
 
 
@@ -569,7 +569,7 @@ template <int dim>
 void
 MGDoFObjectAccessor<3, dim>::copy_from (const MGDoFObjectAccessor<3, dim> &a) {
   DoFObjectAccessor<3, dim>::copy_from (a);
-  set_mg_dof_handler (a.mg_dof_handler);
+  this->set_mg_dof_handler (a.mg_dof_handler);
 };
 
 
@@ -638,7 +638,7 @@ template <>
 MGDoFCellAccessor<3>::face_iterator
 MGDoFCellAccessor<3>::face (const unsigned int i) const
 {
-  return quad(i);
+  return this->quad(i);
 };
 
 #endif
index e5279e9eac7b2cddc26f6ed83e28648b1bf0083a..30b64923f088ec173701fa296e3bb0dac3572be5 100644 (file)
@@ -580,15 +580,15 @@ mirror_refinement_flags (const typename Triangulation<dim>::cell_iterator &new_c
 
   if (old_cell->has_children() && new_cell->has_children()) 
     for (unsigned int c=0; c<GeometryInfo<dim>::children_per_cell; ++c)
-      mirror_refinement_flags<dim> (new_cell->child(c), old_cell->child(c));
+      ::mirror_refinement_flags<dim> (new_cell->child(c), old_cell->child(c));
 };
 
 
 
 template <int dim>
 static bool
-adapt_grids (const typename Triangulation<dim>::cell_iterator &cell1,
-            const typename Triangulation<dim>::cell_iterator &cell2)
+adapt_grid_cells (const typename Triangulation<dim>::cell_iterator &cell1,
+                  const typename Triangulation<dim>::cell_iterator &cell2)
 {
 
   if (cell2->has_children() && cell1->has_children()) 
@@ -596,7 +596,8 @@ adapt_grids (const typename Triangulation<dim>::cell_iterator &cell1,
       bool grids_changed = false;
       
       for (unsigned int c=0; c<GeometryInfo<dim>::children_per_cell; ++c) 
-       grids_changed |= adapt_grids<dim> (cell1->child(c), cell2->child(c));
+       grids_changed |= ::adapt_grid_cells<dim> (cell1->child(c),
+                                                  cell2->child(c));
       return grids_changed;
     };
 
@@ -703,7 +704,7 @@ adapt_grids (Triangulation<dim> &tria1,
          typename Triangulation<dim>::cell_iterator(tria1.end()) :
          tria1.begin(1));
   for (; cell1!=endc; ++cell1, ++cell2)
-    grids_changed |= adapt_grids<dim> (cell1, cell2);
+    grids_changed |= ::adapt_grid_cells<dim> (cell1, cell2);
 
   return grids_changed;
 };
@@ -826,7 +827,7 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
                                         // (there are more coming below then
                                         // also)
        if (refinement_flags.adapt_grids)
-         adapt_grids<dim> (*previous_tria, *tria);
+         ::adapt_grids<dim> (*previous_tria, *tria);
        
                                         // perform flagging of cells
                                         // needed to regularize the
@@ -1083,14 +1084,14 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
                                       // strange things may happen
       if (refinement_flags.mirror_flags_to_previous_grid)
        {
-         adapt_grids<dim> (*previous_tria, *tria);
+         ::adapt_grids<dim> (*previous_tria, *tria);
 
          typename Triangulation<dim>::cell_iterator old_cell, new_cell, endc;
          old_cell = previous_tria->begin(0);
          new_cell = tria->begin(0);
          endc     = tria->end(0);
          for (; new_cell!=endc; ++new_cell, ++old_cell)
-           mirror_refinement_flags<dim> (new_cell, old_cell);
+           ::mirror_refinement_flags<dim> (new_cell, old_cell);
        };
       
       tria->prepare_coarsening_and_refinement ();
@@ -1101,7 +1102,7 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
                                       // cells to avoid the previous grid
                                       // to have cells refined twice more
                                       // than the present one and vica versa.
-      adapt_grids<dim> (*previous_tria, *tria);
+      ::adapt_grids<dim> (*previous_tria, *tria);
     };
 };
 

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.