#include <deal.II/lac/chunk_sparse_matrix.h>
+#include <iterator>
+
#include "../tests.h"
#include <deal.II/lac/chunk_sparse_matrix.h>
+#include <iterator>
+
#include "../tests.h"
dof_handler.distribute_dofs(fe);
AffineConstraints<double> cm;
- DoFTools::make_periodicity_constraints(dof_handler.begin(0)->face(0),
- (++dof_handler.begin(0))->face(1),
- cm);
+ DoFTools::make_periodicity_constraints(
+ dof_handler.begin(0)->face(0),
+ (std::next(dof_handler.begin(0)))->face(1),
+ cm);
deallog << "dim " << std::to_string(dim) << ":" << std::endl;
cm.print(deallog.get_file_stream());
dof_handler.distribute_dofs(fe);
AffineConstraints<double> cm;
- DoFTools::make_periodicity_constraints(dof_handler.begin(0)->face(0),
- (++dof_handler.begin(0))->face(1),
- cm);
+ DoFTools::make_periodicity_constraints(
+ dof_handler.begin(0)->face(0),
+ (std::next(dof_handler.begin(0)))->face(1),
+ cm);
cm.print(deallog.get_file_stream());
}
dof_handler.distribute_dofs(fe);
AffineConstraints<double> cm;
- DoFTools::make_periodicity_constraints(dof_handler.begin(0)->face(0),
- (++dof_handler.begin(0))->face(1),
- cm);
+ DoFTools::make_periodicity_constraints(
+ dof_handler.begin(0)->face(0),
+ (std::next(dof_handler.begin(0)))->face(1),
+ cm);
cm.print(deallog.get_file_stream());
}
std::vector<bool> mask(2, true);
mask[1] = false;
AffineConstraints<double> cm;
- DoFTools::make_periodicity_constraints(dof_handler.begin(0)->face(0),
- (++dof_handler.begin(0))->face(1),
- cm,
- mask);
+ DoFTools::make_periodicity_constraints(
+ dof_handler.begin(0)->face(0),
+ (std::next(dof_handler.begin(0)))->face(1),
+ cm,
+ mask);
cm.print(deallog.get_file_stream());
}
dof_handler.distribute_dofs(fe);
AffineConstraints<std::complex<double>> cm;
- DoFTools::make_periodicity_constraints(dof_handler.begin(0)->face(0),
- (++dof_handler.begin(0))->face(1),
- cm);
+ DoFTools::make_periodicity_constraints(
+ dof_handler.begin(0)->face(0),
+ (std::next(dof_handler.begin(0)))->face(1),
+ cm);
cm.print(deallog.get_file_stream());
}
deallog << dim << " 1/periodicity_factor: " << 1. / periodicity_factor
<< std::endl;
- DoFTools::make_periodicity_constraints(dof_handler.begin(0)->face(0),
- (++dof_handler.begin(0))->face(1),
- cm,
- ComponentMask(),
- true,
- false,
- false,
- FullMatrix<double>(),
- std::vector<unsigned int>(),
- periodicity_factor);
+ DoFTools::make_periodicity_constraints(
+ dof_handler.begin(0)->face(0),
+ (std::next(dof_handler.begin(0)))->face(1),
+ cm,
+ ComponentMask(),
+ true,
+ false,
+ false,
+ FullMatrix<double>(),
+ std::vector<unsigned int>(),
+ periodicity_factor);
cm.print(deallog.get_file_stream());
}
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/lac/sparsity_pattern.h>
+#include <iterator>
+
#include "../tests.h"
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/lac/sparsity_pattern.h>
+#include <iterator>
+
#include "../tests.h"
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
unsigned int hash = 0;
for (unsigned int l = 0; l < sp.n_rows(); ++l)
hash +=
- l * (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
- (sp.row_length(l) > 1 ? ++sp.begin(l) : sp.begin(l))->column());
+ l *
+ (sp.row_length(l) + (sp.begin(l) - sp.begin()) +
+ (sp.row_length(l) > 1 ? std::next(sp.begin(l)) : sp.begin(l))->column());
deallog << hash << std::endl;
}
// Look for the two outermost faces:
typename DoFHandler<dim, spacedim>::face_iterator face_1 =
- (++dof_handler.begin(0))->face(2);
+ (std::next(dof_handler.begin(0)))->face(2);
typename DoFHandler<dim, spacedim>::face_iterator face_2 =
dof_handler.begin(0)->face(2);
// Look for the two outermost faces:
typename DoFHandler<dim, spacedim>::face_iterator face_1 =
- (++dof_handler.begin(0))->face(2);
+ (std::next(dof_handler.begin(0)))->face(2);
typename DoFHandler<dim, spacedim>::face_iterator face_2 =
dof_handler.begin(0)->face(2);
// Look for the two outermost faces:
typename DoFHandler<dim, spacedim>::face_iterator face_1 =
- (++dof_handler.begin(0))->face(2);
+ (std::next(dof_handler.begin(0)))->face(2);
typename DoFHandler<dim, spacedim>::face_iterator face_2 =
dof_handler.begin(0)->face(2);
triangulation_2.refine_global(1);
(std::next(triangulation_2.begin_active()))->set_refine_flag();
triangulation_2.execute_coarsening_and_refinement();
- (++triangulation_2.begin_active(2))->set_refine_flag();
+ (std::next(triangulation_2.begin_active(2)))->set_refine_flag();
triangulation_2.execute_coarsening_and_refinement();
if (dim == 1)
triangulation_2.refine_global(2);
triangulation_2.refine_global(1);
(std::next(triangulation_2.begin_active()))->set_refine_flag();
triangulation_2.execute_coarsening_and_refinement();
- (++triangulation_2.begin_active(2))->set_refine_flag();
+ (std::next(triangulation_2.begin_active(2)))->set_refine_flag();
triangulation_2.execute_coarsening_and_refinement();
if (dim == 1)
triangulation_2.refine_global(2);
triangulation_2.refine_global(1);
(std::next(triangulation_2.begin_active()))->set_refine_flag();
triangulation_2.execute_coarsening_and_refinement();
- (++triangulation_2.begin_active(2))->set_refine_flag();
+ (std::next(triangulation_2.begin_active(2)))->set_refine_flag();
triangulation_2.execute_coarsening_and_refinement();
if (dim == 1)
triangulation_2.refine_global(2);