]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
dofs sublib ISOified for icc -Xc
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 3 Jul 2002 13:31:14 +0000 (13:31 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 3 Jul 2002 13:31:14 +0000 (13:31 +0000)
git-svn-id: https://svn.dealii.org/trunk@6215 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_base.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/grid/tria_accessor.templates.h
deal.II/deal.II/include/grid/tria_iterator.templates.h
deal.II/deal.II/source/dofs/dof_accessor.cc

index 7d1c32fe57e959c85598fd7144ad8c4b02dda53e..0a3d4d6726e69235bd8bbf98d1517958e6293d0c 100644 (file)
@@ -1486,8 +1486,8 @@ unsigned int
 FiniteElementBase<dim>::component_to_system_index (const unsigned int component,
                                                   const unsigned int component_index) const
 {
-  Assert(component<n_components(),
-        ExcIndexRange(component, 0, n_components()));
+  Assert(component<this->n_components(),
+        ExcIndexRange(component, 0, this->n_components()));
   Assert(component_index<component_to_system_table[component].size(),
         ExcIndexRange(component_index, 0,
                       component_to_system_table[component].size()));
@@ -1517,8 +1517,8 @@ unsigned int
 FiniteElementBase<dim>::face_component_to_system_index (const unsigned int component,
                                                        const unsigned int component_index) const
 {
-  Assert(component<n_components(),
-        ExcIndexRange(component, 0, n_components()));
+  Assert(component<this->n_components(),
+        ExcIndexRange(component, 0, this->n_components()));
   Assert(component_index<face_component_to_system_table[component].size(),
         ExcIndexRange(component_index, 0,
                       face_component_to_system_table[component].size()));
@@ -1560,8 +1560,8 @@ inline
 bool
 FiniteElementBase<dim>::restriction_is_additive (const unsigned int component) const
 {
-  Assert(component<n_components(),
-        ExcIndexRange(component, 0, n_components()));
+  Assert(component<this->n_components(),
+        ExcIndexRange(component, 0, this->n_components()));
   return restriction_is_additive_flags[component];
 }
 
@@ -1571,7 +1571,7 @@ inline
 const std::vector<bool> &
 FiniteElementBase<dim>::get_nonzero_components (const unsigned int i) const
 {
-  Assert (i < dofs_per_cell, ExcIndexRange (i, 0, dofs_per_cell));
+  Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
   return nonzero_components[i];
 };
 
@@ -1582,7 +1582,7 @@ inline
 unsigned int
 FiniteElementBase<dim>::n_nonzero_components (const unsigned int i) const
 {
-  Assert (i < dofs_per_cell, ExcIndexRange (i, 0, dofs_per_cell));
+  Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
   return n_nonzero_components_table[i];
 };
 
@@ -1593,7 +1593,7 @@ inline
 bool
 FiniteElementBase<dim>::is_primitive (const unsigned int i) const
 {
-  Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, dofs_per_cell));
+  Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
 
                                   // return primitivity of a shape
                                   // function by checking whether it
index 68a592188935bcd5846e5f7513f91e67aed6c8aa..4ae07bcce3d89f8d0465183003d50304b0df9395 100644 (file)
@@ -1198,7 +1198,7 @@ FEValuesBase<dim>::shape_value (const unsigned int i,
                                     // question to which vector
                                     // component the call of this
                                     // function refers
-    return this->shape_values(shape_function_to_row_table[i], j);
+    return this->shape_values(this->shape_function_to_row_table[i], j);
 }
 
 
@@ -1255,7 +1255,7 @@ FEValuesBase<dim>::shape_value_component (const unsigned int i,
                                       // shape function in the arrays
                                       // we index presently:
       const unsigned int
-       row = (shape_function_to_row_table[i]
+       row = (this->shape_function_to_row_table[i]
               +
               std::count (fe->get_nonzero_components(i).begin(),
                           fe->get_nonzero_components(i).begin()+component,
@@ -1277,9 +1277,9 @@ FEValuesBase<dim>::shape_grad (const unsigned int i,
   Assert (fe->is_primitive (i),
          ExcShapeFunctionNotPrimitive(i));
   Assert (i<this->shape_gradients.size(),
-         ExcIndexRange (i, 0, shape_gradients.size()));
-  Assert (j<shape_gradients[i].size(),
-         ExcIndexRange (j, 0, shape_gradients[i].size()));
+         ExcIndexRange (i, 0, this->shape_gradients.size()));
+  Assert (j<this->shape_gradients[i].size(),
+         ExcIndexRange (j, 0, this->shape_gradients[i].size()));
 
                                   // if the entire FE is primitive,
                                   // then we can take a short-cut:
@@ -1295,7 +1295,7 @@ FEValuesBase<dim>::shape_grad (const unsigned int i,
                                     // question to which vector
                                     // component the call of this
                                     // function refers
-    return this->shape_gradients[shape_function_to_row_table[i]][j];
+    return this->shape_gradients[this->shape_function_to_row_table[i]][j];
 };
 
 
@@ -1352,7 +1352,7 @@ FEValuesBase<dim>::shape_grad_component (const unsigned int i,
                                       // shape function in the arrays
                                       // we index presently:
       const unsigned int
-       row = (shape_function_to_row_table[i]
+       row = (this->shape_function_to_row_table[i]
               +
               std::count (fe->get_nonzero_components(i).begin(),
                           fe->get_nonzero_components(i).begin()+component,
@@ -1374,9 +1374,9 @@ FEValuesBase<dim>::shape_2nd_derivative (const unsigned int i,
   Assert (fe->is_primitive (i),
          ExcShapeFunctionNotPrimitive(i));
   Assert (i<this->shape_2nd_derivatives.size(),
-         ExcIndexRange (i, 0, shape_2nd_derivatives.size()));
+         ExcIndexRange (i, 0, this->shape_2nd_derivatives.size()));
   Assert (j<this->shape_2nd_derivatives[i].size(),
-         ExcIndexRange (j, 0, shape_2nd_derivatives[i].size()));
+         ExcIndexRange (j, 0, this->shape_2nd_derivatives[i].size()));
 
                                   // if the entire FE is primitive,
                                   // then we can take a short-cut:
@@ -1392,7 +1392,7 @@ FEValuesBase<dim>::shape_2nd_derivative (const unsigned int i,
                                     // question to which vector
                                     // component the call of this
                                     // function refers
-    return this->shape_2nd_derivatives[shape_function_to_row_table[i]][j];
+    return this->shape_2nd_derivatives[this->shape_function_to_row_table[i]][j];
 }
 
 
@@ -1449,7 +1449,7 @@ FEValuesBase<dim>::shape_2nd_derivative_component (const unsigned int i,
                                       // shape function in the arrays
                                       // we index presently:
       const unsigned int
-       row = (shape_function_to_row_table[i]
+       row = (this->shape_function_to_row_table[i]
               +
               std::count (fe->get_nonzero_components(i).begin(),
                           fe->get_nonzero_components(i).begin()+component,
@@ -1506,7 +1506,7 @@ template <int dim>
 const Point<dim> &
 FEFaceValuesBase<dim>::normal_vector (const unsigned int i) const
 {
-  Assert (i<this->normal_vectors.size(), ExcIndexRange(i, 0, normal_vectors.size()));
+  Assert (i<this->normal_vectors.size(), ExcIndexRange(i, 0, this->normal_vectors.size()));
   Assert (this->update_flags & update_normal_vectors,
          FEValuesBase<dim>::ExcAccessToUninitializedField());
   
index b270bb2be9727442390ee4973a89b1404d100deb..6afe09b6214dd263fbe9cf1fc751b559bd9b4966 100644 (file)
@@ -718,7 +718,8 @@ inline
 bool
 TriaObjectAccessor<celldim,dim>::used () const
 {
-  Assert (this->state() == IteratorState::valid, ExcDereferenceInvalidObject());
+  Assert (this->state() == IteratorState::valid,
+         typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   return this->tria->levels[this->present_level]->hexes.used[this->present_index];
 };
 
@@ -729,7 +730,7 @@ inline
 bool
 TriaObjectAccessor<celldim,dim>::user_flag_set () const
 {
-  Assert (this->used(), ExcCellNotUsed());
+  Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->hexes.user_flags[this->present_index];
 };
 
@@ -740,7 +741,7 @@ inline
 void
 TriaObjectAccessor<celldim,dim>::set_user_flag () const
 {
-  Assert (this->used(), ExcCellNotUsed());
+  Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.user_flags[this->present_index] = true;
 };
 
@@ -750,7 +751,7 @@ template<int celldim, int dim>
 inline
 void TriaObjectAccessor<celldim,dim>::clear_user_flag () const
 {
-  Assert (this->used(), ExcCellNotUsed());
+  Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.user_flags[this->present_index] = false;
 };
 
@@ -761,7 +762,7 @@ inline
 TriaIterator<dim,TriaObjectAccessor<1,dim> >
 TriaObjectAccessor<celldim,dim>::line (const unsigned int i) const
 {
-  Assert (this->used(), ExcCellNotUsed());
+  Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   Assert (i < GeometryInfo<celldim>::lines_per_cell,
          ExcIndexRange(i,0,GeometryInfo<celldim>::lines_per_cell));
 
@@ -808,7 +809,7 @@ inline
 TriaIterator<dim,TriaObjectAccessor<2,dim> >
 TriaObjectAccessor<celldim,dim>::quad (const unsigned int i) const
 {
-  Assert (this->used(), ExcCellNotUsed());
+  Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   Assert (i < GeometryInfo<celldim>::quads_per_cell,
          ExcIndexRange(i,0,GeometryInfo<celldim>::quads_per_cell));
   return
@@ -887,7 +888,7 @@ TriaObjectAccessor<celldim,dim>::child (const unsigned int i) const
     q (this->tria, this->present_level+1, child_index (i));
   
   Assert ((q.state() == IteratorState::past_the_end) || q->used(),
-         ExcUnusedCellAsChild());
+         typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 
   return q;
 };
index afa1f5b6e450df12098f80cf0d9a7341feffeef3..c8b4b63a815793039d804a5778b28b087706f107 100644 (file)
@@ -334,7 +334,7 @@ TriaActiveIterator<dim,Accessor>::operator = (const TriaRawIterator<dim,Accessor
                                   // state==IteratorState::past_the_end, and will then
                                   // throw the exception!
   if (this->state() != IteratorState::past_the_end) 
-    Assert (this->accessor.used() && accessor.has_children()==false,
+    Assert (this->accessor.used() && this->accessor.has_children()==false,
            ExcAssignmentOfInactiveObject());
 #endif  
   return *this;
index 7a3699327916fd08340f701190056363db56a35a..788de3f216775c360d64d12a1d5d089e47b37e7e 100644 (file)
@@ -39,7 +39,7 @@ void DoFObjectAccessor<1, dim>::set_dof_index (const unsigned int i,
                                   // and enough room was reserved
   Assert (this->dof_handler->selected_fe != 0, DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->selected_fe->dofs_per_line,
-         ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_line));
+         ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_line));
 
   this->dof_handler->levels[this->present_level]
     ->line_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_line+i] = index;
@@ -70,7 +70,7 @@ void DoFObjectAccessor<1, dim>::set_vertex_dof_index (const unsigned int vertex,
          typename BaseClass::ExcInvalidObject());
   Assert (vertex<2, ExcIndexRange (i,0,2));
   Assert (i<this->dof_handler->selected_fe->dofs_per_vertex,
-         ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_vertex));
+         ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_vertex));
 
   const unsigned int dof_number = (this->vertex_index(vertex) *
                                   this->dof_handler->selected_fe->dofs_per_vertex +
@@ -101,7 +101,7 @@ distribute_local_to_global (const Vector<double> &local_source,
   Assert (this->dof_handler->selected_fe != 0,
          typename BaseClass::ExcInvalidObject());
   Assert (local_source.size() == (2*this->dof_handler->get_fe().dofs_per_vertex +
-                                 dof_handler->get_fe().dofs_per_line),
+                                 this->dof_handler->get_fe().dofs_per_line),
          typename BaseClass::ExcVectorDoesNotMatch());
   Assert (this->dof_handler->n_dofs() == global_destination.size(),
          typename BaseClass::ExcVectorDoesNotMatch());
@@ -140,7 +140,7 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
   Assert (this->dof_handler->selected_fe != 0,
          typename BaseClass::ExcInvalidObject());
   Assert (local_source.m() == (2*this->dof_handler->get_fe().dofs_per_vertex +
-                              dof_handler->get_fe().dofs_per_line),
+                              this->dof_handler->get_fe().dofs_per_line),
          typename BaseClass::ExcVectorDoesNotMatch());
   Assert (local_source.m() == local_source.n(),
          typename BaseClass::ExcMatrixDoesNotMatch());
@@ -238,7 +238,7 @@ void DoFObjectAccessor<2, dim>::set_dof_index (const unsigned int i,
   Assert (this->dof_handler->selected_fe != 0,
          typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->selected_fe->dofs_per_quad,
-         ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_quad));
+         ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_quad));
 
   this->dof_handler->levels[this->present_level]
     ->quad_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_quad+i] = index;
@@ -258,7 +258,7 @@ DoFObjectAccessor<2, dim>::set_vertex_dof_index (const unsigned int vertex,
          typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (vertex<4, ExcIndexRange (i,0,4));
   Assert (i<this->dof_handler->selected_fe->dofs_per_vertex,
-         ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_vertex));
+         ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_vertex));
 
   const unsigned int dof_number = (this->vertex_index(vertex) *
                                   this->dof_handler->selected_fe->dofs_per_vertex +
@@ -277,8 +277,8 @@ distribute_local_to_global (const Vector<double> &local_source,
   Assert (this->dof_handler->selected_fe != 0,
          typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (local_source.size() == (4*this->dof_handler->get_fe().dofs_per_vertex +
-                                 4*dof_handler->get_fe().dofs_per_line +
-                                 dof_handler->get_fe().dofs_per_quad),
+                                 4*this->dof_handler->get_fe().dofs_per_line +
+                                 this->dof_handler->get_fe().dofs_per_quad),
          typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
   Assert (this->dof_handler->n_dofs() == global_destination.size(),
          typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
@@ -305,8 +305,8 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
   Assert (this->dof_handler->selected_fe != 0,
          typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (local_source.m() == (4*this->dof_handler->get_fe().dofs_per_vertex +
-                              4*dof_handler->get_fe().dofs_per_line +
-                              dof_handler->get_fe().dofs_per_quad),
+                              4*this->dof_handler->get_fe().dofs_per_line +
+                              this->dof_handler->get_fe().dofs_per_quad),
          typename DoFAccessor<dim>::ExcMatrixDoesNotMatch());
   Assert (local_source.m() == local_source.n(),
          typename DoFAccessor<dim>::ExcMatrixDoesNotMatch());
@@ -418,7 +418,7 @@ void DoFObjectAccessor<3, dim>::set_dof_index (const unsigned int i,
   Assert (this->dof_handler->selected_fe != 0,
          typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->selected_fe->dofs_per_hex,
-         ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_hex));
+         ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_hex));
 
   this->dof_handler->levels[this->present_level]
     ->hex_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_hex+i] = index;
@@ -438,7 +438,7 @@ void DoFObjectAccessor<3, dim>::set_vertex_dof_index (const unsigned int vertex,
   Assert (vertex<8,
          ExcIndexRange (i,0,8));
   Assert (i<this->dof_handler->selected_fe->dofs_per_vertex,
-         ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_vertex));
+         ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_vertex));
 
   const unsigned int dof_number = (this->vertex_index(vertex) *
                                   this->dof_handler->selected_fe->dofs_per_vertex +
@@ -458,9 +458,9 @@ distribute_local_to_global (const Vector<double> &local_source,
   Assert (this->dof_handler->selected_fe != 0,
          typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (local_source.size() == (8*this->dof_handler->get_fe().dofs_per_vertex +
-                                 12*dof_handler->get_fe().dofs_per_line +
-                                 6*dof_handler->get_fe().dofs_per_quad +
-                                 dof_handler->get_fe().dofs_per_hex),
+                                 12*this->dof_handler->get_fe().dofs_per_line +
+                                 6*this->dof_handler->get_fe().dofs_per_quad +
+                                 this->dof_handler->get_fe().dofs_per_hex),
          typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
   Assert (this->dof_handler->n_dofs() == global_destination.size(),
          typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
@@ -488,9 +488,9 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
   Assert (this->dof_handler->selected_fe != 0,
          typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (local_source.m() == (8*this->dof_handler->get_fe().dofs_per_vertex +
-                              12*dof_handler->get_fe().dofs_per_line +
-                              6*dof_handler->get_fe().dofs_per_quad +
-                              dof_handler->get_fe().dofs_per_hex),
+                              12*this->dof_handler->get_fe().dofs_per_line +
+                              6*this->dof_handler->get_fe().dofs_per_quad +
+                              this->dof_handler->get_fe().dofs_per_hex),
          typename DoFAccessor<dim>::ExcMatrixDoesNotMatch());
   Assert (local_source.m() == local_source.n(),
          typename DoFAccessor<dim>::ExcMatrixDoesNotMatch());
@@ -532,8 +532,8 @@ DoFObjectAccessor<3,dim>::get_dof_values (const InputVector &values,
   
   const unsigned int dofs_per_vertex = this->dof_handler->get_fe().dofs_per_vertex,
                     dofs_per_line   = this->dof_handler->get_fe().dofs_per_line,
-                    dofs_per_quad   = dof_handler->get_fe().dofs_per_quad,
-                    dofs_per_hex    = dof_handler->get_fe().dofs_per_hex;
+                    dofs_per_quad   = this->dof_handler->get_fe().dofs_per_quad,
+                    dofs_per_hex    = this->dof_handler->get_fe().dofs_per_hex;
   typename Vector<number>::iterator next_local_value = local_values.begin();
   for (unsigned int vertex=0; vertex<GeometryInfo<3>::vertices_per_cell; ++vertex)
     for (unsigned int d=0; d<dofs_per_vertex; ++d)
@@ -574,8 +574,8 @@ DoFObjectAccessor<3,dim>::set_dof_values (const Vector<number> &local_values,
   
   const unsigned int dofs_per_vertex = this->dof_handler->get_fe().dofs_per_vertex,
                     dofs_per_line   = this->dof_handler->get_fe().dofs_per_line,
-                    dofs_per_quad   = dof_handler->get_fe().dofs_per_quad,
-                    dofs_per_hex    = dof_handler->get_fe().dofs_per_hex;
+                    dofs_per_quad   = this->dof_handler->get_fe().dofs_per_quad,
+                    dofs_per_hex    = this->dof_handler->get_fe().dofs_per_hex;
   typename Vector<number>::const_iterator next_local_value=local_values.begin();
   for (unsigned int vertex=0; vertex<GeometryInfo<dim>::vertices_per_cell; ++vertex)
     for (unsigned int d=0; d<dofs_per_vertex; ++d)
@@ -684,9 +684,9 @@ DoFCellAccessor<dim>::get_interpolated_dof_values (const InputVector &values,
          for (unsigned int i=0; i<dofs_per_cell; ++i)
            {
              const unsigned int component
-               = dof_handler->get_fe().system_to_component_index(i).first;
+               = this->dof_handler->get_fe().system_to_component_index(i).first;
          
-             if (dof_handler->get_fe().restriction_is_additive(component)) 
+             if (this->dof_handler->get_fe().restriction_is_additive(component)) 
                interpolated_values(i) += tmp2(i);
              else
                if (tmp2(i) != 0)

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.