]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Gratuitiously sprinkle some this-> to make icc7 happier.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 13 Dec 2002 16:37:13 +0000 (16:37 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 13 Dec 2002 16:37:13 +0000 (16:37 +0000)
git-svn-id: https://svn.dealii.org/trunk@6812 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/source/fe/fe_q.cc
deal.II/deal.II/source/fe/fe_system.cc
deal.II/lac/include/lac/block_sparse_matrix.h
deal.II/lac/include/lac/sparse_decomposition.templates.h
deal.II/lac/include/lac/sparse_ilu.templates.h
deal.II/lac/include/lac/sparse_matrix.h
deal.II/lac/include/lac/sparse_mic.templates.h
deal.II/lac/include/lac/sparse_vanka.templates.h

index 3a57551c163794f6f7bbcea47abdc1949560abd7..74673d97b3216da411e3d7b275754a814a31c857 100644 (file)
@@ -1355,14 +1355,14 @@ FE_Q<dim>::has_support_on_face (const unsigned int shape_index,
                                        // shape functions, since they
                                        // have no support no-where on
                                        // the boundary
-      if (((dim==2) && (shape_index>=first_quad_index))
+      if (((dim==2) && (shape_index>=this->first_quad_index))
           ||
-          ((dim==3) && (shape_index>=first_hex_index)))
+          ((dim==3) && (shape_index>=this->first_hex_index)))
         return false;
                                        
                                        // let's see whether this is a
                                        // vertex
-      if (shape_index < first_line_index) 
+      if (shape_index < this->first_line_index) 
         {
                                            // for Q elements, there is
                                            // one dof per vertex, so
@@ -1404,7 +1404,7 @@ FE_Q<dim>::has_support_on_face (const unsigned int shape_index,
                                          // ok, dof is on a line
         {
           const unsigned int line_index
-            = (shape_index - first_line_index) / dofs_per_line;
+            = (shape_index - first_line_index) / this->dofs_per_line;
           Assert (line_index < GeometryInfo<dim>::lines_per_cell,
                   ExcInternalError());
 
@@ -1435,7 +1435,7 @@ FE_Q<dim>::has_support_on_face (const unsigned int shape_index,
                                          // dof is on a quad
         {
           const unsigned int quad_index 
-            = (shape_index - first_quad_index) / dofs_per_quad;
+            = (shape_index - first_quad_index) / this->dofs_per_quad;
           Assert (static_cast<signed int>(quad_index) <
                   static_cast<signed int>(GeometryInfo<dim>::quads_per_cell),
                   ExcInternalError());
index 29d507738557bbaf14a2116b47b15fdeed9bf2be..739b6769f3ad16d7cc932bab10fd4f8e5c1e1c67 100644 (file)
@@ -2222,8 +2222,8 @@ bool
 FESystem<dim>::has_support_on_face (const unsigned int shape_index,
                                    const unsigned int face_index) const
 {
-  return (base_element(system_to_base_index(shape_index).first.first)
-          .has_support_on_face(system_to_base_index(shape_index).second,
+  return (base_element(this->system_to_base_index(shape_index).first.first)
+          .has_support_on_face(this->system_to_base_index(shape_index).second,
                                face_index));
 }
 
@@ -2235,8 +2235,8 @@ FESystem<dim>::unit_support_point (const unsigned index) const
 {
   Assert (index < this->dofs_per_cell,
           ExcIndexRange (index, 0, this->dofs_per_cell));
-  Assert ((unit_support_points.size() == this->dofs_per_cell) ||
-          (unit_support_points.size() == 0),
+  Assert ((this->unit_support_points.size() == this->dofs_per_cell) ||
+          (this->unit_support_points.size() == 0),
           typename FiniteElementBase<dim>::ExcFEHasNoSupportPoints ());
 
                                    // let's see whether we have the
@@ -2247,8 +2247,8 @@ FESystem<dim>::unit_support_point (const unsigned index) const
                                      // no. ask the base element
                                      // whether it would like to
                                      // provide this information
-    return (base_element(system_to_base_index(index).first.first)
-            .unit_support_point(system_to_base_index(index).second));
+    return (base_element(this->system_to_base_index(index).first.first)
+            .unit_support_point(this->system_to_base_index(index).second));
 };
 
 
@@ -2259,8 +2259,8 @@ FESystem<dim>::unit_face_support_point (const unsigned index) const
 {
   Assert (index < this->dofs_per_face,
           ExcIndexRange (index, 0, this->dofs_per_face));
-  Assert ((unit_face_support_points.size() == this->dofs_per_face) ||
-          (unit_face_support_points.size() == 0),
+  Assert ((this->unit_face_support_points.size() == this->dofs_per_face) ||
+          (this->unit_face_support_points.size() == 0),
           typename FiniteElementBase<dim>::ExcFEHasNoSupportPoints ());
 
                                    // let's see whether we have the
@@ -2271,8 +2271,8 @@ FESystem<dim>::unit_face_support_point (const unsigned index) const
                                      // no. ask the base element
                                      // whether it would like to
                                      // provide this information
-    return (base_element(face_system_to_base_index(index).first.first)
-            .unit_face_support_point(face_system_to_base_index(index).second));
+    return (base_element(this->face_system_to_base_index(index).first.first)
+            .unit_face_support_point(this->face_system_to_base_index(index).second));
 };
 
 
index 79cfcdf0eb414cee712e01928d94a046a3ca905f..1789d4382f2679a5ecbe9589540283c11b98137c 100644 (file)
@@ -834,7 +834,7 @@ BlockSparseMatrix<number>::const_iterator::operator++ ()
          this->col_start = 0;
          this->a_index = 0;
          ++local_row;
-         if (local_row>=this->matrix->block(block_row,0).m())
+         if (local_row>=this->matrix->block(this->block_row,0).m())
            {
                                               // If final row in
                                               // block, go to next
index 52911d63ffed0ef8fc9e2bba3630949b7e200f7b..bc31a7adda0c46e4f7c6f3079147d650676ca272 100644 (file)
@@ -88,9 +88,11 @@ template<typename number>
 void
 SparseLUDecomposition<number>::prebuild_lower_bound()
 {
-  const unsigned int* const column_numbers = get_sparsity_pattern().get_column_numbers();
-  const unsigned int* const rowstart_indices = get_sparsity_pattern().get_rowstart_indices();
-  const unsigned int N = m();
+  const unsigned int * const
+    column_numbers = this->get_sparsity_pattern().get_column_numbers();
+  const unsigned int * const
+    rowstart_indices = this->get_sparsity_pattern().get_rowstart_indices();
+  const unsigned int N = this->m();
 
   prebuilt_lower_bound.resize (N);
 
@@ -108,8 +110,8 @@ void
 SparseLUDecomposition<number>::copy_from (const SparseMatrix<somenumber>& matrix)
 {
                                    // preset the elements
-  std::fill_n (&global_entry(0),
-               n_nonzero_elements(),
+  std::fill_n (&this->global_entry(0),
+               this->n_nonzero_elements(),
                0);
 
                                    // note: pointers to the sparsity
@@ -120,10 +122,10 @@ SparseLUDecomposition<number>::copy_from (const SparseMatrix<somenumber>& matrix
   const unsigned int * const column_numbers
     = matrix.get_sparsity_pattern().get_column_numbers();
 
-  for (unsigned int row=0; row<m(); ++row)
+  for (unsigned int row=0; row<this->m(); ++row)
     for (const unsigned int * col = &column_numbers[rowstart_indices[row]];
          col != &column_numbers[rowstart_indices[row+1]]; ++col)
-      set (row, *col, matrix.global_entry(col-column_numbers));
+      this->set (row, *col, matrix.global_entry(col-column_numbers));
 }
 
 
@@ -132,19 +134,20 @@ template <typename number>
 void
 SparseLUDecomposition<number>::strengthen_diagonal_impl ()
 {
-  for (unsigned int row=0; row<m(); ++row)
+  for (unsigned int row=0; row<this->m(); ++row)
     {
                                        // get the length of the row
                                        // (without the diagonal element)
-      const unsigned int rowlength = get_sparsity_pattern().get_rowstart_indices()[row+1]
-                                     -get_sparsity_pattern().get_rowstart_indices()[row]
-                                     -1;
+      const unsigned int rowlength
+        = (this->get_sparsity_pattern().get_rowstart_indices()[row+1]
+           -this->get_sparsity_pattern().get_rowstart_indices()[row]
+           -1);
        
                                        // get the global index of the first
                                        // non-diagonal element in this row
       const unsigned int rowstart
         = get_sparsity_pattern().get_rowstart_indices()[row] + 1;
-      number * const diagonal_element = &global_entry(rowstart-1);
+      number * const diagonal_element = &this->global_entry(rowstart-1);
 
       number rowsum = 0;
       for (unsigned int global_index=rowstart;
index 617da1df7f426c163937adbbd640a233cccecb45..8d7a5ab659b8df0709d4177dd4adae3b28133179 100644 (file)
@@ -46,10 +46,10 @@ void SparseILU<number>::decompose (const SparseMatrix<somenumber> &matrix,
   
   Assert (strengthen_diagonal>=0, ExcInvalidStrengthening (strengthen_diagonal));
 
-  copy_from (matrix);
+  this->copy_from (matrix);
 
-  if(strengthen_diagonal>0)
-    strengthen_diagonal_impl();
+  if (strengthen_diagonal>0)
+    this->strengthen_diagonal_impl();
 
   const SparsityPattern             &sparsity = this->get_sparsity_pattern();
   const unsigned int * const rowstart_indices = sparsity.get_rowstart_indices();
@@ -93,7 +93,7 @@ void SparseILU<number>::decompose (const SparseMatrix<somenumber> &matrix,
                                       // diagonal element at start
       const unsigned int * first_of_row
        = &column_numbers[rowstart_indices[row]+1];
-      const unsigned int * first_after_diagonal = prebuilt_lower_bound[row];
+      const unsigned int * first_after_diagonal = this->prebuilt_lower_bound[row];
 
                                       // k := *col_ptr
       for (const unsigned int * col_ptr = first_of_row;
@@ -184,7 +184,7 @@ void SparseILU<number>::vmult (Vector<somenumber>       &dst,
       const unsigned int * const rowstart = &column_numbers[rowstart_indices[row]+1];
                                       // find the position where the part
                                       // right of the diagonal starts
-      const unsigned int * const first_after_diagonal = prebuilt_lower_bound[row];
+      const unsigned int * const first_after_diagonal = this->prebuilt_lower_bound[row];
       
       for (const unsigned int * col=rowstart; col!=first_after_diagonal; ++col)
        dst(row) -= this->global_entry (col-column_numbers) * dst(*col);
@@ -204,7 +204,7 @@ void SparseILU<number>::vmult (Vector<somenumber>       &dst,
       const unsigned int * const rowend = &column_numbers[rowstart_indices[row+1]];
                                       // find the position where the part
                                       // right of the diagonal starts
-      const unsigned int * const first_after_diagonal = prebuilt_lower_bound[row];
+      const unsigned int * const first_after_diagonal = this->prebuilt_lower_bound[row];
       
       for (const unsigned int * col=first_after_diagonal; col!=rowend; ++col)
        dst(row) -= this->global_entry (col-column_numbers) * dst(*col);
index 19b58f9d64198255b3b8165e16bf0627fb16aacd..2b0f95c846bcb4fee3c586d0e32ec2ce59614712 100644 (file)
@@ -1387,10 +1387,11 @@ inline
 typename SparseMatrix<number>::const_iterator&
 SparseMatrix<number>::const_iterator::operator++ ()
 {
-  Assert (this->a_row < matrix->m(), ExcIteratorPastEnd());
+  Assert (this->a_row < this->matrix->m(), ExcIteratorPastEnd());
   
   ++this->a_index;
-  if (this->a_index >= this->matrix->get_sparsity_pattern().row_length(this->a_row))
+  if (this->a_index >=
+      this->matrix->get_sparsity_pattern().row_length(this->a_row))
     {
       this->a_index = 0;
       this->a_row++;
index b8fe5339486bb8467a1b46b8d304b0fb1f468696..07a4cbc13354ce9ee7d75e0a924416a3c83c03c3 100644 (file)
@@ -95,13 +95,13 @@ void SparseMIC<number>::decompose (const SparseMatrix<somenumber> &matrix,
   SparseLUDecomposition<number>::decompose(matrix, strengthen_diagonal);
 
   Assert (matrix.m()==matrix.n(), ExcMatrixNotSquare ());
-  Assert (m()==n(),               ExcMatrixNotSquare ());
-  Assert (matrix.m()==m(),        ExcSizeMismatch(matrix.m(), m()));
+  Assert (this->m()==this->n(),   ExcMatrixNotSquare ());
+  Assert (matrix.m()==this->m(),  ExcSizeMismatch(matrix.m(), this->m()));
 
   Assert (strengthen_diagonal>=0, ExcInvalidStrengthening (strengthen_diagonal));
 
   if (strengthen_diagonal > 0)
-    strengthen_diagonal_impl ();
+    this->strengthen_diagonal_impl ();
 
                                    // MIC implementation: (S. Margenov lectures)
                                    // x[i] = a[i][i] - sum(k=1, i-1,
@@ -112,22 +112,22 @@ void SparseMIC<number>::decompose (const SparseMatrix<somenumber> &matrix,
                                    // implementation would store this
                                    // values in the underlying sparse
                                    // matrix itself.
-  diag.resize (m());
-  inv_diag.resize (m());
-  inner_sums.resize (m());
+  diag.resize (this->m());
+  inv_diag.resize (this->m());
+  inner_sums.resize (this->m());
 
                                    // precalc sum(j=k+1, N, a[k][j]))
   for(unsigned int row=0; row<m(); row++) {
     inner_sums[row] = get_rowsum(row);
   }
 
-  const unsigned int* const col_nums = get_sparsity_pattern().get_column_numbers();
-  const unsigned int* const rowstarts = get_sparsity_pattern().get_rowstart_indices();
+  const unsigned int* const col_nums = this->get_sparsity_pattern().get_column_numbers();
+  const unsigned int* const rowstarts = this->get_sparsity_pattern().get_rowstart_indices();
 
-  for(unsigned int row=0; row<m(); row++) {
-    number temp = diag_element(row);
+  for(unsigned int row=0; row<this->m(); row++) {
+    number temp = this->diag_element(row);
     number temp1 = 0;
-    const unsigned int * const first_after_diagonal = prebuilt_lower_bound[row];
+    const unsigned int * const first_after_diagonal = this->prebuilt_lower_bound[row];
 
     unsigned int k = 0;
     for (const unsigned int * col=&col_nums[rowstarts[row]+1];
@@ -146,19 +146,19 @@ template <typename number>
 inline number
 SparseMIC<number>::get_rowsum (const unsigned int row) const
 {
-  Assert(m()==n(), ExcMatrixNotSquare());
+  Assert(this->m()==this->n(), ExcMatrixNotSquare());
                                    // get start of this row. skip the
                                    // diagonal element
-  const unsigned int * const column_numbers = get_sparsity_pattern().get_column_numbers();
-  const unsigned int * const rowstart_indices = get_sparsity_pattern().get_rowstart_indices();
+  const unsigned int * const column_numbers = this->get_sparsity_pattern().get_column_numbers();
+  const unsigned int * const rowstart_indices = this->get_sparsity_pattern().get_rowstart_indices();
   const unsigned int * const rowend = &column_numbers[rowstart_indices[row+1]];
 
                                    // find the position where the part
                                    // right of the diagonal starts
-  const unsigned int * const first_after_diagonal = prebuilt_lower_bound[row];
+  const unsigned int * const first_after_diagonal = this->prebuilt_lower_bound[row];
   number rowsum =  0;
   for (const unsigned int * col=first_after_diagonal; col!=rowend; ++col)
-    rowsum += global_entry (col-column_numbers);
+    rowsum += this->global_entry (col-column_numbers);
 
   return rowsum;       
 };
@@ -173,11 +173,11 @@ SparseMIC<number>::vmult (Vector<somenumber>       &dst,
 {
   SparseLUDecomposition<number>::vmult (dst, src);
   Assert (dst.size() == src.size(), ExcSizeMismatch(dst.size(), src.size()));
-  Assert (dst.size() == m(), ExcSizeMismatch(dst.size(), m()));
+  Assert (dst.size() == this->m(), ExcSizeMismatch(dst.size(), this->m()));
 
   const unsigned int N=dst.size();
-  const unsigned int * const rowstart_indices = get_sparsity_pattern().get_rowstart_indices();
-  const unsigned int * const column_numbers   = get_sparsity_pattern().get_column_numbers();
+  const unsigned int * const rowstart_indices = this->get_sparsity_pattern().get_rowstart_indices();
+  const unsigned int * const column_numbers   = this->get_sparsity_pattern().get_column_numbers();
                                    // We assume the underlying matrix A is:
                                    // A = X - L - U, where -L and -U are
                                    // strictly lower- and upper- diagonal
@@ -193,9 +193,9 @@ SparseMIC<number>::vmult (Vector<somenumber>       &dst,
                                        // get start of this row. skip
                                        // the diagonal element
       const unsigned int * const rowstart = &column_numbers[rowstart_indices[row]+1];
-      const unsigned int * const fad = prebuilt_lower_bound[row];
+      const unsigned int * const fad = this->prebuilt_lower_bound[row];
       for (const unsigned int * col=rowstart; col!=fad; ++col)
-        dst(row) -= global_entry (col-column_numbers) * dst(*col);
+        dst(row) -= this->global_entry (col-column_numbers) * dst(*col);
       
       dst(row) *= inv_diag[row];
     };
@@ -209,9 +209,9 @@ SparseMIC<number>::vmult (Vector<somenumber>       &dst,
     {
                                       // get end of this row
       const unsigned int * const rowend = &column_numbers[rowstart_indices[row+1]];
-      const  unsigned int * const fad = prebuilt_lower_bound[row];
+      const  unsigned int * const fad = this->prebuilt_lower_bound[row];
       for (const unsigned int * col=fad; col!=rowend; ++col)
-        dst(row) -= global_entry (col-column_numbers) * dst(*col);
+        dst(row) -= this->global_entry (col-column_numbers) * dst(*col);
 
       dst(row) *= inv_diag[row];
     };
index db19779f8505f04b74d957f5ff3c3096ef15be4a..67105dd0d0d3a3b4ee9420a83745392e1976bf8e 100644 (file)
@@ -575,7 +575,7 @@ void SparseBlockVanka<number>::vmult (Vector<number2>       &dst,
                                   // if no blocking is required, pass
                                   // down to the underlying class
   if (n_blocks == 1)
-    apply_preconditioner (dst, src);
+    this->apply_preconditioner (dst, src);
   else
                                     // otherwise: blocking requested
     {
@@ -610,8 +610,8 @@ void SparseBlockVanka<number>::vmult (Vector<number2>       &dst,
         }
       else
         for (unsigned int block=0; block<n_blocks; ++block)
-          apply_preconditioner (dst, src,
-                                &dof_masks[block]);
+          this->apply_preconditioner (dst, src,
+                                      &dof_masks[block]);
     }
 }
 

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.