test()
{
deallog << "---- Creating outer table" << std::endl;
- Table<1, C> table({1});
+ Table<1, C> table(1);
// Copy the object, then destroy the copy again.
{
}
SymmetricTensor<2, dim>
- hessian(const Point<dim> &, const unsigned int) const
+ hessian(const Point<dim> &, const unsigned int) const override
{
SymmetricTensor<2, dim> hess;
for (unsigned int i = 0; i < dim; ++i)
values[CellId("0_1:2")] = Vector<double>{0.5, 0.5, 0.5, 0.5};
values[CellId("0_1:3")] = Vector<double>{0.5, 0.1, 0.5, 0.5};
- for (const auto cell : dof_handler.active_cell_iterators())
+ for (const auto &cell : dof_handler.active_cell_iterators())
if (cell->is_artificial() == false)
cell->set_dof_values(values[cell->id()], v);
{
Point<dim> middle = FlatManifold<dim>::get_new_point_on_quad(quad);
- // if the face is at the top of bottom
+ // if the face is at the top or bottom
// face: do not move the midpoint in
// x/y direction. Note that if the
// z-value of the midpoint is either
// 0 or 1, then the z-values of all
// vertices of the quad is like that
- if (dim == 3 && (middle(dim - 1) == 0) || (middle(dim - 1) == 1))
+ if (dim == 3 && ((middle(dim - 1) == 0) || (middle(dim - 1) == 1)))
return middle;
double x = middle(0), y = middle(1);
{
typename FEValuesViews::View<dim, spacedim, Extractor>::
template solution_value_type<double>
- t1;
+ t1{};
typename FEValuesViews::View<dim, spacedim, Extractor>::
template solution_gradient_type<double>
- t2;
+ t2{};
deallog << "Test<" << Utilities::dim_string(dim, spacedim) << '>' << std::endl
<< Utilities::type_to_string(t1) << std::endl
Triangulation<2> tria2;
GridGenerator::hyper_ball(tria);
- for (const auto cell : tria.active_cell_iterators())
+ for (const auto &cell : tria.active_cell_iterators())
{
if (cell->center()[0] < 0)
cell->set_refine_flag();
}
tria.execute_coarsening_and_refinement();
- for (const auto cell : tria.active_cell_iterators())
+ for (const auto &cell : tria.active_cell_iterators())
{
if (cell->center()[1] < 0)
cell->set_refine_flag();
{
Point<dim> middle = FlatManifold<dim>::get_new_point_on_line(line);
- // if the line is at the top of bottom
+ // if the line is at the top or bottom
// face: do a special treatment on
// this line. Note that if the
// z-value of the midpoint is either
// z-value of the midpoint is either
// 0 or 1, then the z-values of all
// vertices of the quad is like that
- if (dim == 3 && (middle(dim - 1) == 0) || (middle(dim - 1) == 1))
+ if (dim == 3 && ((middle(dim - 1) == 0) || (middle(dim - 1) == 1)))
return middle;
double x = middle(0), y = middle(1);
}
for (unsigned int i = 0; i < constraint_entries_1->size(); ++i)
{
- if (std::abs((*constraint_entries_1)[i].first !=
- (*constraint_entries_2)[i].first) > tol ||
+ if ((*constraint_entries_1)[i].first !=
+ (*constraint_entries_2)[i].first ||
std::abs((*constraint_entries_1)[i].second -
(*constraint_entries_2)[i].second) > tol)
{