]> https://gitweb.dealii.org/ - dealii.git/commitdiff
cppcheck: prefer ++i to i++
authorDavid Wells <drwells@email.unc.edu>
Mon, 13 May 2019 14:58:02 +0000 (10:58 -0400)
committerDavid Wells <drwells@email.unc.edu>
Mon, 13 May 2019 17:26:52 +0000 (13:26 -0400)
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/trilinos_vector.h
source/lac/sparsity_pattern.cc
source/lac/trilinos_vector.cc

index d4ae0455fb511fcd55363065742163cd0b673df8..76ec303b349c48d59e35d8b35e062ba523cd11c9 100644 (file)
@@ -897,7 +897,7 @@ namespace internal
       for (size_type i = begin_row; i < end_row; ++i)
         {
           typename InVector::value_type s = 0;
-          for (size_type j = rowstart[i]; j < rowstart[i + 1]; j++)
+          for (size_type j = rowstart[i]; j < rowstart[i + 1]; ++j)
             s += typename InVector::value_type(values[j]) * v(colnums[j]);
           norm_sqr +=
             v(i) *
@@ -963,7 +963,7 @@ namespace internal
       for (size_type i = begin_row; i < end_row; ++i)
         {
           typename InVector::value_type s = 0;
-          for (size_type j = rowstart[i]; j < rowstart[i + 1]; j++)
+          for (size_type j = rowstart[i]; j < rowstart[i + 1]; ++j)
             s += typename InVector::value_type(values[j]) * v(colnums[j]);
           norm_sqr +=
             u(i) *
@@ -1307,7 +1307,7 @@ namespace internal
       for (size_type i = begin_row; i < end_row; ++i)
         {
           typename OutVector::value_type s = b(i);
-          for (size_type j = rowstart[i]; j < rowstart[i + 1]; j++)
+          for (size_type j = rowstart[i]; j < rowstart[i + 1]; ++j)
             s -= typename OutVector::value_type(values[j]) * u(colnums[j]);
           dst(i) = s;
           norm_sqr +=
index 95a9a8fdc0295c5de04001bd4ec8915b60ab2912..2eb90f7c055d6b733738105410cb301ab9316c8b 100644 (file)
@@ -1869,7 +1869,7 @@ namespace TrilinosWrappers
 
       // loop over all the elements because
       // Trilinos does not support lp norms
-      for (size_type i = 0; i < n_local; i++)
+      for (size_type i = 0; i < n_local; ++i)
         sum += std::pow(std::fabs((*vector)[0][i]), p);
 
       norm = std::pow(sum, static_cast<TrilinosScalar>(1. / p));
@@ -1981,7 +1981,7 @@ namespace TrilinosWrappers
       AssertIsFinite(s);
 
       size_type n_local = local_size();
-      for (size_type i = 0; i < n_local; i++)
+      for (size_type i = 0; i < n_local; ++i)
         (*vector)[0][i] += s;
     }
 
index 0f46463aed06089ab7b643deebaa0f933038f9a7..17c1e7de4d21c3c3814c8bca115f4e7c5d915725 100644 (file)
@@ -324,7 +324,7 @@ SparsityPattern::reinit(const size_type                      m,
   // if diagonal elements are special: let the first entry in each row be the
   // diagonal value
   if (store_diagonal_first_in_row)
-    for (size_type i = 0; i < rows; i++)
+    for (size_type i = 0; i < rows; ++i)
       colnums[rowstart[i]] = i;
 
   compressed = false;
@@ -784,7 +784,7 @@ SparsityPatternBase::exists(const size_type i, const size_type j) const
   Assert(i < rows, ExcIndexRange(i, 0, rows));
   Assert(j < cols, ExcIndexRange(j, 0, cols));
 
-  for (size_type k = rowstart[i]; k < rowstart[i + 1]; k++)
+  for (size_type k = rowstart[i]; k < rowstart[i + 1]; ++k)
     {
       // entry already exists
       if (colnums[k] == j)
@@ -802,7 +802,7 @@ SparsityPatternBase::row_position(const size_type i, const size_type j) const
   Assert(i < rows, ExcIndexRange(i, 0, rows));
   Assert(j < cols, ExcIndexRange(j, 0, cols));
 
-  for (size_type k = rowstart[i]; k < rowstart[i + 1]; k++)
+  for (size_type k = rowstart[i]; k < rowstart[i + 1]; ++k)
     {
       // entry exists
       if (colnums[k] == j)
@@ -856,7 +856,7 @@ SparsityPatternBase::symmetrize()
   // 2. that the @p{add} function can be called on elements that already exist
   // without any harm
   for (size_type row = 0; row < rows; ++row)
-    for (size_type k = rowstart[row]; k < rowstart[row + 1]; k++)
+    for (size_type k = rowstart[row]; k < rowstart[row + 1]; ++k)
       {
         // check whether we are at the end of the entries of this row. if so,
         // go to next row
index 5adf4bb6e3641ba5fb89e1cb507b53d2764f0a5e..8a0af6fdc0e98e78654e1a7f3add05b9d50171cb 100644 (file)
@@ -718,7 +718,7 @@ namespace TrilinosWrappers
         return false;
 
       size_type i;
-      for (i = 0; i < local_size(); i++)
+      for (i = 0; i < local_size(); ++i)
         if ((*(v.vector))[0][i] != (*vector)[0][i])
           return false;
 

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.