From: Peter Munch Date: Sat, 26 Dec 2020 20:06:46 +0000 (+0100) Subject: Fix formating X-Git-Tag: v9.3.0-rc1~720^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F11421%2Fhead;p=dealii.git Fix formating --- diff --git a/include/deal.II/fe/fe_tools.templates.h b/include/deal.II/fe/fe_tools.templates.h index 4a72f1d9cd..7833e04cba 100644 --- a/include/deal.II/fe/fe_tools.templates.h +++ b/include/deal.II/fe/fe_tools.templates.h @@ -2196,11 +2196,7 @@ namespace FETools const std::vector &JxW = coarse.get_JxW_values(); for (unsigned int i = 0; i < n; ++i) for (unsigned int j = 0; j < n; ++j) - if (fe. - - is_primitive() - - ) + if (fe.is_primitive()) { const double *coarse_i = &coarse.shape_value(i, 0); const double *coarse_j = &coarse.shape_value(j, 0); @@ -2220,13 +2216,11 @@ namespace FETools } // invert mass matrix - mass. - - gauss_jordan(); + mass.gauss_jordan(); } - auto compute_one_case = + const auto compute_one_case = [&fe, &q_fine, n, nd, nq](const unsigned int ref_case, const FullMatrix &inverse_mass_matrix, std::vector> &matrices) { @@ -2235,42 +2229,17 @@ namespace FETools for (unsigned int i = 0; i < nc; ++i) { - Assert(matrices[i]. - - n() - - == n, - ExcDimensionMismatch(matrices[i]. - - n(), - n - - )); - Assert(matrices[i]. - - m() - - == n, - ExcDimensionMismatch(matrices[i]. - - m(), - n - - )); + Assert(matrices[i].n() == n, + ExcDimensionMismatch(matrices[i].n(), n)); + Assert(matrices[i].m() == n, + ExcDimensionMismatch(matrices[i].m(), n)); } // create a respective refinement on the triangulation Triangulation tr; GridGenerator::hyper_cube(tr, 0, 1); - tr. - - begin_active() - -> - - set_refine_flag(RefinementCase(ref_case)); - tr. - - execute_coarsening_and_refinement(); + tr.begin_active()->set_refine_flag(RefinementCase(ref_case)); + tr.execute_coarsening_and_refinement(); FEValues fine(StaticMappingQ1::mapping, fe, @@ -2293,16 +2262,8 @@ namespace FETools fine.reinit(coarse_cell->child(cell_number)); const std::vector> &q_points_fine = fine.get_quadrature_points(); - std::vector> q_points_coarse(q_points_fine. - - size() - - ); - for (unsigned int q = 0; q < q_points_fine. - - size(); - - ++q) + std::vector> q_points_coarse(q_points_fine.size()); + for (unsigned int q = 0; q < q_points_fine.size(); ++q) for (unsigned int j = 0; j < dim; ++j) q_points_coarse[q](j) = q_points_fine[q](j); Quadrature q_coarse(q_points_coarse, fine.get_JxW_values()); @@ -2322,11 +2283,7 @@ namespace FETools { for (unsigned int i = 0; i < fe.n_dofs_per_cell(); ++i) { - if (fe. - - is_primitive() - - ) + if (fe.is_primitive()) { const double *coarse_i = &coarse.shape_value(i, 0); const double *fine_j = &fine.shape_value(j, 0); @@ -2355,16 +2312,8 @@ namespace FETools } // Remove small entries from the matrix - for (unsigned int i = 0; i < this_matrix. - - m(); - - ++i) - for (unsigned int j = 0; j < this_matrix. - - n(); - - ++j) + for (unsigned int i = 0; i < this_matrix.m(); ++i) + for (unsigned int j = 0; j < this_matrix.n(); ++j) if (std::fabs(this_matrix(i, j)) < 1e-12) this_matrix(i, j) = 0.; } @@ -2381,9 +2330,7 @@ namespace FETools compute_one_case(ref_case, mass, matrices[ref_case - 1]); }); - tasks. - - join_all(); + tasks.join_all(); }