std::cout << std::endl
<< "Time step #" << timestep_number << "; "
- << "advancing to t = " << time << "." << std::endl;
+ << "advancing to t = " << time << '.' << std::endl;
// At the beginning of each time step we must solve the nonlinear
// equation in the split formulation via Newton's method ---
int,
std::string,
<< "Name at position " << arg1 << " is not equal to " << arg2
- << ".");
+ << '.');
private:
/// The stored data
const char *,
const char *,
<< "The stored type for entry with name \"" << arg1 << "\" is "
- << arg2 << " but you requested type " << arg3 << ".");
+ << arg2 << " but you requested type " << arg3 << '.');
private:
/**
* << "Timestep: " << time.get_step_number() << " -- "
* << "Solving for the solution at "
* << "t = " << time_of_simulation << " with "
- * << "dt = " << timestep_size << "." << std::endl;
+ * << "dt = " << timestep_size << '.' << std::endl;
* // } end snapshot stage
*
* // update stage {
DeclException2(ExcDimensionMismatch,
std::size_t,
std::size_t,
- << "Dimension " << arg1 << " not equal to " << arg2 << ".");
+ << "Dimension " << arg1 << " not equal to " << arg2 << '.');
/**
* The first dimension should be either equal to the second or the third,
std::size_t,
std::size_t,
<< "Dimension " << arg1 << " neither equal to " << arg2
- << " nor to " << arg3 << ".");
+ << " nor to " << arg3 << '.');
/**
* This exception indicates that an index is not within the expected range.
int,
int,
<< "Number " << arg1 << " must be larger than or equal "
- << arg2 << ".");
+ << arg2 << '.');
/**
* A generic exception definition for the ExcLowerRange above.
T,
T,
<< "Number " << arg1 << " must be larger than or equal "
- << arg2 << ".");
+ << arg2 << '.');
/**
* This exception indicates that the first argument should be an integer
<< "The input interpolation points are not strictly ordered : "
<< std::endl
<< "x[" << arg1 << "] = " << arg2 << " >= x[" << (arg1 + 1)
- << "] = " << arg3 << ".");
+ << "] = " << arg3 << '.');
DeclException3(
ExcCSplineRange,
*/
DeclException1(ExcEntryAlreadyExists,
std::string,
- << "The following entry already exists: " << arg1 << ".");
+ << "The following entry already exists: " << arg1 << '.');
/**
* Exception
*/
types::global_dof_index,
unsigned int,
<< "Global index " << arg1
- << " neither owned nor ghost on proc " << arg2 << ".");
+ << " neither owned nor ghost on proc " << arg2 << '.');
/**
* Exception
std::string,
std::string,
<< "The file \"" << arg1 << "\" was not found in the path for "
- << "files of class " << arg2 << ".");
+ << "files of class " << arg2 << '.');
private:
/**
int,
<< "The dimension " << arg1
<< " in the finite element string must match "
- << "the space dimension " << arg2 << ".");
+ << "the space dimension " << arg2 << '.');
/**
* Exception
<< arg1 << "] is distorted. The cell geometry or the "
<< "mapping are invalid, giving a non-positive volume "
<< "fraction of " << arg2 << " in quadrature point " << arg3
- << ".");
+ << '.');
/**
* @}
DeclException1(ExcScalingFactorNotPositive,
double,
<< "The scaling factor must be positive, but it is " << arg1
- << ".");
+ << '.');
/**
* Exception
<< arg1
<< " of a triangulation, but this triangulation only has "
<< arg2 << " refinement levels. The given level " << arg1
- << " must be *less* than " << arg2 << ".");
+ << " must be *less* than " << arg2 << '.');
/**
* The function raising this exception can only operate on an empty
* Triangulation, i.e., a Triangulation without grid cells.
ExcSetOnlyEvenChildren,
int,
<< "You can only set the child index of an even numbered child."
- << "The number of the child given was " << arg1 << ".");
+ << "The number of the child given was " << arg1 << '.');
} // namespace TriaAccessorExceptions
TriaRawIterator<Accessor>::print(StreamType &out) const
{
if (Accessor::structure_dimension == Accessor::dimension)
- out << accessor.level() << "." << accessor.index();
+ out << accessor.level() << '.' << accessor.index();
else
out << accessor.index();
}
<< "The entry for the indices " << arg1 << " and " << arg2
<< " already exists, but the values " << arg3 << " (old) and "
<< arg4 << " (new) differ "
- << "by " << (arg4 - arg3) << ".");
+ << "by " << (arg4 - arg3) << '.');
/**
* Exception
*
size_type,
size_type,
<< "The given index " << arg1 << " should be less than "
- << arg2 << ".");
+ << arg2 << '.');
/**
* Exception
*/
ExcUMFPACKError,
std::string,
int,
- << "UMFPACK routine " << arg1 << " returned error status " << arg2 << "."
+ << "UMFPACK routine " << arg1 << " returned error status " << arg2 << '.'
<< "\n\n"
<< ("A complete list of error codes can be found in the file "
"<bundled/umfpack/UMFPACK/Include/umfpack.h>."
int,
<< "You have to give one name per component in your "
<< "data vector. The number you gave was " << arg1
- << ", but the number of components is " << arg2 << ".");
+ << ", but the number of components is " << arg2 << '.');
/**
* Exception
*/
int,
<< "The number of rows in the input matrix is " << arg1
<< ", but needs to be either " << arg2 << " or " << arg3
- << ".");
+ << '.');
/**
int,
<< "The number of rows in the input matrix is " << arg1
<< ", but needs to be either " << arg2 << "," << arg3
- << ", or " << arg4 << ".");
+ << ", or " << arg4 << '.');
/**
int,
<< "The number of columns in the input matrix is " << arg1
<< ", but needs to be either " << arg2 << " or " << arg3
- << ".");
+ << '.');
/**
int,
<< "The number of columns in the input matrix is " << arg1
<< ", but needs to be either " << arg2 << "," << arg3
- << ", or " << arg4 << ".");
+ << ", or " << arg4 << '.');
/**
<< Utilities::System::get_time();
}
else
- out << ".";
+ out << '.';
out << '\n' << "ASCII" << '\n';
// now output the data header
out << "DATASET UNSTRUCTURED_GRID\n" << '\n';
<< Utilities::System::get_date();
}
else
- out << ".";
+ out << '.';
out << "\n-->\n";
out << "<VTKFile type=\"UnstructuredGrid\" version=\"0.1\"";
#ifdef DEAL_II_WITH_ZLIB
<< std::endl;
}
out << "The numerical value of the original error code is " << error_code
- << "." << std::endl;
+ << '.' << std::endl;
}
#endif // DEAL_II_WITH_MPI
int,
<< "Error while creating cell " << arg1
<< ": the vertex index " << arg2 << " must be between 0 and "
- << arg3 << ".");
+ << arg3 << '.');
/**
* Exception
* @ingroup Exceptions
}
#endif // DEAL_II_WITH_PETSC
out << "The numerical value of the original error code is " << error_code
- << "." << std::endl;
+ << '.' << std::endl;
}
} // namespace LACExceptions
std::max(1e-13, 1e-13 * std::fabs(value1)))
deallog << "Error scale at x=" << x << ": p(t)=" << value1
<< ", q(x)=" << value2 << std::endl;
- deallog << ".";
+ deallog << '.';
}
deallog << std::endl;
}
std::max(1e-13, 1e-13 * std::fabs(value1)))
deallog << "Error shift at x=" << x << ": p(t)=" << value1
<< ", q(x)=" << value2 << std::endl;
- deallog << ".";
+ deallog << '.';
}
deallog << std::endl;
}
std::max(1e-13, 1e-13 * std::fabs(value1)))
deallog << "Error multiply at x=" << x << ": a*p(x)=" << value1
<< ", q(x)=" << value2 << std::endl;
- deallog << ".";
+ deallog << '.';
}
deallog << std::endl;
}
<< ": p_1(x)*p_2(x)=" << value1 << ", q(x)=" << value2
<< std::endl;
}
- deallog << ".";
+ deallog << '.';
}
deallog << std::endl;
}
std::max(1e-10, 1e-10 * std::fabs(value1)))
deallog << "Error expansion at x=" << x << ": p(x)=" << value1
<< ", q(x)=" << value2 << std::endl;
- deallog << ".";
+ deallog << '.';
}
deallog << std::endl;
}
<< j << "(x)=" << value1 << ", q(x)=" << value2
<< std::endl;
}
- deallog << ".";
+ deallog << '.';
}
deallog << std::endl;
}
{
value += p[i].value(x);
}
- deallog << ".";
+ deallog << '.';
if (std::fabs(1. - value) > 1e-13)
deallog << "Error1 lg y=" << std::log10(std::fabs(1. - value))
<< std::endl;
q.value(x, values_ref);
for (unsigned int i = 0; i < n_deriv; ++i)
{
- deallog << ".";
+ deallog << '.';
if (std::fabs(values[i] - values_ref[i]) >
std::max(1e-11, 1e-11 * std::fabs(values[i])))
deallog << "Error deriv" << i << " lg y="
}
catch (...)
{
- deallog << ".";
+ deallog << '.';
}
deallog << std::endl;
}
data_out.add_data_vector(dh, v, "1");
data_out.build_patches(1);
std::ostringstream filename;
- filename << filename_ << Utilities::int_to_string(loop, 2) << "."
+ filename << filename_ << Utilities::int_to_string(loop, 2) << '.'
<< Utilities::int_to_string(myid, 2) << ".vtu";
std::ofstream output(filename.str().c_str());
std::ostringstream filename;
filename
- << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << "."
+ << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << '.'
<< Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
<< ".vtu";
std::ostringstream filename;
filename
- << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << "."
+ << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << '.'
<< Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
<< ".vtu";
std::ostringstream filename;
filename
- << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << "."
+ << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << '.'
<< Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
<< ".vtu";
{
for (unsigned int i = 0; i < path.size(); ++i)
{
- deallog << path[i] << ".";
+ deallog << path[i] << '.';
}
deallog << entry << " = ";
<< " : ";
deallog << "Convergence step " << result_mf.first << " value "
- << result_mf.second << "." << std::endl;
+ << result_mf.second << '.' << std::endl;
};
compare(mf_algo(), mb_algo());
deallog << "Convergence step " << std::get<0>(result_mf) << " value "
<< std::get<1>(result_mf) << " max " << std::get<2>(result_mf)
- << " norm " << std::get<3>(result_mf) << "." << std::endl;
+ << " norm " << std::get<3>(result_mf) << '.' << std::endl;
};
compare(mf_algo(), mb_algo());