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) *
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) *
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 +=
// 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));
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;
}
// 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;
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)
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)
// 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
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;