]> https://gitweb.dealii.org/ - dealii.git/commitdiff
cppcheck: use ++i, not i++.
authorDavid Wells <drwells@email.unc.edu>
Sat, 9 May 2020 19:28:34 +0000 (15:28 -0400)
committerDavid Wells <drwells@email.unc.edu>
Sat, 9 May 2020 23:24:48 +0000 (19:24 -0400)
include/deal.II/base/mpi_compute_index_owner_internal.h
include/deal.II/lac/full_matrix.templates.h
include/deal.II/lac/sparse_decomposition.templates.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/sparse_mic.templates.h

index 33afc8c1a1581177fd4ee56c8f0c8d1c30138335..91092aa273f713b0b0ceddf6b5bb3e389162ab2b 100644 (file)
@@ -243,7 +243,7 @@ namespace Utilities
             // 2) collect relevant processes and process local dict entries
             for (auto interval = owned_indices.begin_intervals();
                  interval != owned_indices.end_intervals();
-                 interval++)
+                 ++interval)
               {
                 // Due to the granularity of the dictionary, the interval
                 // might be split into several ranges of processor owner
@@ -737,7 +737,7 @@ namespace Utilities
 
             for (auto interval = is.begin_intervals();
                  interval != is.end_intervals();
-                 interval++)
+                 ++interval)
               send_buffer.emplace_back(*interval->begin(),
                                        interval->last() + 1);
           }
index 9aa608ba691be8f7217b9dea905bca7a9f37ceed..e5d8726a29483ca046ea38b9fca040d9ed14786e 100644 (file)
@@ -582,11 +582,11 @@ FullMatrix<number>::mmult(FullMatrix<number2> &      dst,
   // arrange the loops in a way that we keep write operations low, (writing is
   // usually more costly than reading), even though we need to access the data
   // in src not in a contiguous way.
-  for (size_type i = 0; i < m; i++)
-    for (size_type j = 0; j < n; j++)
+  for (size_type i = 0; i < m; ++i)
+    for (size_type j = 0; j < n; ++j)
       {
         number2 add_value = adding ? dst(i, j) : 0.;
-        for (size_type k = 0; k < l; k++)
+        for (size_type k = 0; k < l; ++k)
           add_value += static_cast<number2>((*this)(i, k)) *
                        static_cast<number2>((src(k, j)));
         dst(i, j) = add_value;
@@ -687,11 +687,11 @@ FullMatrix<number>::Tmmult(FullMatrix<number2> &      dst,
   // optimized gemm operation in case the matrix is big, so this shouldn't be
   // too bad.
   else
-    for (size_type i = 0; i < m; i++)
-      for (size_type j = 0; j < n; j++)
+    for (size_type i = 0; i < m; ++i)
+      for (size_type j = 0; j < n; ++j)
         {
           number2 add_value = adding ? dst(i, j) : 0.;
-          for (size_type k = 0; k < l; k++)
+          for (size_type k = 0; k < l; ++k)
             add_value += static_cast<number2>((*this)(k, i)) *
                          static_cast<number2>((src(k, j)));
           dst(i, j) = add_value;
@@ -788,11 +788,11 @@ FullMatrix<number>::mTmult(FullMatrix<number2> &      dst,
   else
     // arrange the loops in a way that we keep write operations low, (writing is
     // usually more costly than reading).
-    for (size_type i = 0; i < m; i++)
-      for (size_type j = 0; j < n; j++)
+    for (size_type i = 0; i < m; ++i)
+      for (size_type j = 0; j < n; ++j)
         {
           number2 add_value = adding ? dst(i, j) : 0.;
-          for (size_type k = 0; k < l; k++)
+          for (size_type k = 0; k < l; ++k)
             add_value += static_cast<number2>((*this)(i, k)) *
                          static_cast<number2>(src(j, k));
           dst(i, j) = add_value;
@@ -873,11 +873,11 @@ FullMatrix<number>::TmTmult(FullMatrix<number2> &      dst,
   // in the calling matrix in a non-contiguous way, possibly leading to cache
   // misses. However, we should usually end up in the optimized gemm operation
   // in case the matrix is big, so this shouldn't be too bad.
-  for (size_type i = 0; i < m; i++)
-    for (size_type j = 0; j < n; j++)
+  for (size_type i = 0; i < m; ++i)
+    for (size_type j = 0; j < n; ++j)
       {
         number2 add_value = adding ? dst(i, j) : 0.;
-        for (size_type k = 0; k < l; k++)
+        for (size_type k = 0; k < l; ++k)
           add_value += static_cast<number2>((*this)(k, i)) *
                        static_cast<number2>(src(j, k));
         dst(i, j) = add_value;
@@ -1560,13 +1560,13 @@ FullMatrix<number>::cholesky(const FullMatrix<number2> &A)
       /* reinit *this to 0 */
       this->reinit(A.m(), A.n());
 
-      for (size_type i = 0; i < this->n_cols(); i++)
+      for (size_type i = 0; i < this->n_cols(); ++i)
         {
           double SLik2 = 0.0;
-          for (size_type j = 0; j < i; j++)
+          for (size_type j = 0; j < i; ++j)
             {
               double SLikLjk = 0.0;
-              for (size_type k = 0; k < j; k++)
+              for (size_type k = 0; k < j; ++k)
                 {
                   SLikLjk += (*this)(i, k) * (*this)(j, k);
                 };
@@ -1591,9 +1591,9 @@ FullMatrix<number>::outer_product(const Vector<number2> &V,
          ExcMessage("Vectors V, W must be the same size."));
   this->reinit(V.size(), V.size());
 
-  for (size_type i = 0; i < this->n(); i++)
+  for (size_type i = 0; i < this->n(); ++i)
     {
-      for (size_type j = 0; j < this->n(); j++)
+      for (size_type j = 0; j < this->n(); ++j)
         {
           (*this)(i, j) = V(i) * W(j);
         }
@@ -1697,8 +1697,8 @@ FullMatrix<number>::copy_from(const Tensor<2, dim> &T,
   AssertIndexRange(src_r_i, src_r_j + 1);
   AssertIndexRange(src_c_i, src_c_j + 1);
 
-  for (size_type i = 0; i < src_r_j - src_r_i + 1; i++)
-    for (size_type j = 0; j < src_c_j - src_c_i + 1; j++)
+  for (size_type i = 0; i < src_r_j - src_r_i + 1; ++i)
+    for (size_type j = 0; j < src_c_j - src_c_i + 1; ++j)
       {
         const unsigned int src_r_index = static_cast<unsigned int>(i + src_r_i);
         const unsigned int src_c_index = static_cast<unsigned int>(j + src_c_i);
@@ -1725,8 +1725,8 @@ void FullMatrix<number>::copy_to(Tensor<2, dim> &   T,
   AssertIndexRange(src_r_i, src_r_j + 1);
   AssertIndexRange(src_c_j, src_c_j + 1);
 
-  for (size_type i = 0; i < src_r_j - src_r_i + 1; i++)
-    for (size_type j = 0; j < src_c_j - src_c_i + 1; j++)
+  for (size_type i = 0; i < src_r_j - src_r_i + 1; ++i)
+    for (size_type j = 0; j < src_c_j - src_c_i + 1; ++j)
       {
         const unsigned int dst_r_index = static_cast<unsigned int>(i + dst_r);
         const unsigned int dst_c_index = static_cast<unsigned int>(j + dst_c);
index 6a9571cbf0faa5e3d214176877f1f1f4369ffc9a..d642c1873143e036da60fccc88bb546e52bd7aa2 100644 (file)
@@ -150,7 +150,7 @@ SparseLUDecomposition<number>::prebuild_lower_bound()
 
   prebuilt_lower_bound.resize(N);
 
-  for (size_type row = 0; row < N; row++)
+  for (size_type row = 0; row < N; ++row)
     {
       prebuilt_lower_bound[row] =
         Utilities::lower_bound(&column_numbers[rowstart_indices[row] + 1],
index 9636e89cbf7703e3e9e30fb17e6d1b11582efd36..3933a20fa6e932e3ce0ffd061fbfb510b0f38037 100644 (file)
@@ -808,9 +808,9 @@ SparseMatrix<number>::Tvmult(OutVector &dst, const InVector &src) const
 
   dst = 0;
 
-  for (size_type i = 0; i < m(); i++)
+  for (size_type i = 0; i < m(); ++i)
     {
-      for (size_type j = cols->rowstart[i]; j < cols->rowstart[i + 1]; j++)
+      for (size_type j = cols->rowstart[i]; j < cols->rowstart[i + 1]; ++j)
         {
           const size_type p = cols->colnums[j];
           dst(p) += typename OutVector::value_type(val[j]) *
@@ -864,8 +864,8 @@ SparseMatrix<number>::Tvmult_add(OutVector &dst, const InVector &src) const
 
   Assert(!PointerComparison::equal(&src, &dst), ExcSourceEqualsDestination());
 
-  for (size_type i = 0; i < m(); i++)
-    for (size_type j = cols->rowstart[i]; j < cols->rowstart[i + 1]; j++)
+  for (size_type i = 0; i < m(); ++i)
+    for (size_type j = cols->rowstart[i]; j < cols->rowstart[i + 1]; ++j)
       {
         const size_type p = cols->colnums[j];
         dst(p) += typename OutVector::value_type(val[j]) *
@@ -1851,10 +1851,10 @@ SparseMatrix<number>::SSOR(Vector<somenumber> &dst, const number om) const
   size_type       j;
   somenumber      s;
 
-  for (size_type i = 0; i < n; i++)
+  for (size_type i = 0; i < n; ++i)
     {
       s = 0.;
-      for (j = cols->rowstart[i]; j < cols->rowstart[i + 1]; j++)
+      for (j = cols->rowstart[i]; j < cols->rowstart[i + 1]; ++j)
         {
           const size_type p = cols->colnums[j];
           if (p != SparsityPattern::invalid_entry)
@@ -1871,7 +1871,7 @@ SparseMatrix<number>::SSOR(Vector<somenumber> &dst, const number om) const
        i--) // this time, i is signed, but always positive!
     {
       s = 0.;
-      for (j = cols->rowstart[i]; j < cols->rowstart[i + 1]; j++)
+      for (j = cols->rowstart[i]; j < cols->rowstart[i + 1]; ++j)
         {
           const size_type p = cols->colnums[j];
           if (p != SparsityPattern::invalid_entry)
index b74393a1123c36c948ef5ff7b872fa249fb123f5..398bd9fbb70b49746a8058e2146e7ba9ada628a2 100644 (file)
@@ -101,10 +101,10 @@ SparseMIC<number>::initialize(const SparseMatrix<somenumber> &matrix,
   inner_sums.resize(this->m());
 
   // precalc sum(j=k+1, N, a[k][j]))
-  for (size_type row = 0; row < this->m(); row++)
+  for (size_type row = 0; row < this->m(); ++row)
     inner_sums[row] = get_rowsum(row);
 
-  for (size_type row = 0; row < this->m(); row++)
+  for (size_type row = 0; row < this->m(); ++row)
     {
       const number temp  = this->begin(row)->value();
       number       temp1 = 0;
@@ -176,7 +176,7 @@ SparseMIC<number>::vmult(Vector<somenumber> &      dst,
     }
 
   // Now: v = Xu
-  for (size_type row = 0; row < N; row++)
+  for (size_type row = 0; row < N; ++row)
     dst(row) *= diag[row];
 
   // x = (X-U)v

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.