if (timestep_number != 0)
{
double min_temperature = std::numeric_limits<double>::max(),
- max_temperature = -std::numeric_limits<double>::max();
+ max_temperature = std::numeric_limits<double>::lowest();
for (const auto &cell : temperature_dof_handler.active_cell_iterators())
{
else
{
double min_temperature = std::numeric_limits<double>::max(),
- max_temperature = -std::numeric_limits<double>::max();
+ max_temperature = std::numeric_limits<double>::lowest();
for (const auto &cell : temperature_dof_handler.active_cell_iterators())
{
// entropy as well as keeps track of the area/volume of the part of the
// domain we locally own and the integral over the entropy on it:
double min_entropy = std::numeric_limits<double>::max(),
- max_entropy = -std::numeric_limits<double>::max(), area = 0,
+ max_entropy = std::numeric_limits<double>::lowest(), area = 0,
entropy_integrated = 0;
for (const auto &cell : temperature_dof_handler.active_cell_iterators())
std::vector<double> old_old_temperature_values(n_q_points);
double min_local_temperature = std::numeric_limits<double>::max(),
- max_local_temperature = -std::numeric_limits<double>::max();
+ max_local_temperature = std::numeric_limits<double>::lowest();
if (timestep_number != 0)
{
<< " CG iterations for temperature" << std::endl;
double temperature[2] = {std::numeric_limits<double>::max(),
- -std::numeric_limits<double>::max()};
+ std::numeric_limits<double>::lowest()};
double global_temperature[2];
for (unsigned int i =
// ensure that we can ignore them should they show up in our
// computations.
double min_spurious_eigenvalue = std::numeric_limits<double>::max(),
- max_spurious_eigenvalue = -std::numeric_limits<double>::max();
+ max_spurious_eigenvalue = std::numeric_limits<double>::lowest();
for (unsigned int i = 0; i < dof_handler.n_dofs(); ++i)
if (constraints.is_constrained(i))
mpi_communicator);
double residual_norm;
- double previous_residual_norm = -std::numeric_limits<double>::max();
+ double previous_residual_norm = std::numeric_limits<double>::lowest();
const double correct_sigma = sigma_0;
if (timestep_number != 0)
{
double min_saturation = std::numeric_limits<double>::max(),
- max_saturation = -std::numeric_limits<double>::max();
+ max_saturation = std::numeric_limits<double>::lowest();
for (const auto &cell : saturation_dof_handler.active_cell_iterators())
{
else
{
double min_saturation = std::numeric_limits<double>::max(),
- max_saturation = -std::numeric_limits<double>::max();
+ max_saturation = std::numeric_limits<double>::lowest();
for (const auto &cell : saturation_dof_handler.active_cell_iterators())
{