]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Assert* should end with a semicolon
authorDaniel Arndt <arndtd@ornl.gov>
Thu, 21 Sep 2023 14:54:34 +0000 (10:54 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Fri, 22 Sep 2023 15:27:47 +0000 (11:27 -0400)
33 files changed:
include/deal.II/base/function.templates.h
include/deal.II/base/symmetric_tensor.templates.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/integrators/grad_div.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/full_matrix.templates.h
source/base/data_out_base.cc
source/base/function_signed_distance.cc
source/base/mpi.cc
source/base/polynomial.cc
source/base/table_handler.cc
source/distributed/repartitioning_policy_tools.cc
source/distributed/shared_tria.cc
source/dofs/dof_handler_policy.cc
source/dofs/dof_tools_constraints.cc
source/fe/fe_poly_tensor.cc
source/grid/grid_generator.cc
source/grid/grid_tools.cc
source/grid/tria.cc
source/lac/petsc_vector_base.cc
source/lac/sparsity_tools.cc
source/numerics/data_out_faces.cc
tests/base/point_02.cc
tests/fe/fe_values_no_mapping.cc
tests/matrix_free/stokes_computation.cc
tests/mpi/trilinos_sparse_matrix_03.cc
tests/multigrid-global-coarsening/stokes_computation.cc
tests/non_matching/immersed_surface_quadrature.cc
tests/numerics/no_flux_18.cc
tests/sharedtria/tria_multigrid_01.cc
tests/sharedtria/tria_zorder_01.cc
tests/simplex/q_projection_01.cc
tests/simplex/simplex_grids.h

index b12d3e8640c6c922f1489de69b7f968e2298b050..fae02036d5a680d132fad97a5dca18ec1910b2d4 100644 (file)
@@ -407,11 +407,11 @@ namespace Functions
     (void)points;
     AssertIndexRange(component, this->n_components);
     Assert(return_values.size() == points.size(),
-           ExcDimensionMismatch(return_values.size(), points.size()))
+           ExcDimensionMismatch(return_values.size(), points.size()));
 
-      std::fill(return_values.begin(),
-                return_values.end(),
-                function_value_vector[component]);
+    std::fill(return_values.begin(),
+              return_values.end(),
+              function_value_vector[component]);
   }
 
 
index ce092f084ed3df902fa604a8b720724fe889d1ac..c246c9f350550d2621267e962bc460e3c67f3168 100644 (file)
@@ -308,8 +308,9 @@ namespace internal
                   AssertThrow(
                     false,
                     ExcMessage(
-                      "No convergence in iterative QL eigenvector algorithm.")) return std::
-                    array<std::pair<Number, Tensor<1, dim, Number>>, dim>();
+                      "No convergence in iterative QL eigenvector algorithm."));
+                  return std::array<std::pair<Number, Tensor<1, dim, Number>>,
+                                    dim>();
                 }
 
               // Calculate the shift..
@@ -445,8 +446,9 @@ namespace internal
               AssertThrow(
                 false,
                 ExcMessage(
-                  "No convergence in iterative Jacobi eigenvector algorithm.")) return std::
-                array<std::pair<Number, Tensor<1, dim, Number>>, dim>();
+                  "No convergence in iterative Jacobi eigenvector algorithm."));
+              return std::array<std::pair<Number, Tensor<1, dim, Number>>,
+                                dim>();
             }
 
           // Compute threshold value which dictates whether or
index 7461abedaf486d96111bb5110dec193ac372ee84..fa1faae8d01c0b07e56f42ad7acc4a014dd037eb 100644 (file)
@@ -66,7 +66,7 @@ namespace FETools
                            const DoFHandler<dim, spacedim> & /*dof2*/,
                            OutVector & /*u2*/)
       {
-        Assert(false, ExcNotImplemented())
+        Assert(false, ExcNotImplemented());
       }
     };
 
@@ -373,7 +373,7 @@ namespace FETools
     public:
       ExtrapolateImplementation()
       {
-        AssertThrow(false, ExcNotImplemented())
+        AssertThrow(false, ExcNotImplemented());
       }
 
       template <class InVector>
@@ -390,7 +390,7 @@ namespace FETools
     public:
       ExtrapolateImplementation()
       {
-        AssertThrow(false, ExcNotImplemented())
+        AssertThrow(false, ExcNotImplemented());
       }
 
       template <class InVector>
@@ -407,7 +407,7 @@ namespace FETools
     public:
       ExtrapolateImplementation()
       {
-        AssertThrow(false, ExcNotImplemented())
+        AssertThrow(false, ExcNotImplemented());
       }
 
       template <class InVector>
index 82b5ad1ed128fff4b69d82da366bba2a872b4f90..fffeb7839ea4adfb83eedb7a4a84bc382725a85c 100644 (file)
@@ -180,8 +180,8 @@ namespace LocalIntegrators
                      double factor = 1.)
     {
       const unsigned int n_dofs = fe.dofs_per_cell;
-      AssertDimension(fe.get_fe().n_components(), dim)
-        AssertVectorVectorDimension(input, dim, fe.n_quadrature_points);
+      AssertDimension(fe.get_fe().n_components(), dim);
+      AssertVectorVectorDimension(input, dim, fe.n_quadrature_points);
       AssertVectorVectorDimension(Dinput, dim, fe.n_quadrature_points);
       AssertVectorVectorDimension(data, dim, fe.n_quadrature_points);
 
index c751739db691564ae9f9c3f2c1d21742b4429adb..77e72087be53eee06311dfa3ef37f046e7fcfd7d 100644 (file)
@@ -1939,8 +1939,9 @@ BlockMatrixBase<MatrixType>::add(const size_type  row,
         if (col_indices[i] <= before)
           Assert(false,
                  ExcMessage("Flag col_indices_are_sorted is set, but "
-                            "indices appear to not be sorted.")) else before =
-            col_indices[i];
+                            "indices appear to not be sorted."));
+        else
+          before = col_indices[i];
 #  endif
       const std::pair<unsigned int, size_type> row_index =
         this->row_block_indices.global_to_local(row);
index 395e3fbaec49f82acb81c8aa327b61e3125f3c0a..f9544a31cdcb6b9016805f6c004d4919081e2eec 100644 (file)
@@ -1614,7 +1614,8 @@ FullMatrix<number>::left_invert(const FullMatrix<number2> &A)
   A_t.Tadd(A, 1);
   A_t.mmult(A_t_times_A, A);
   if (number(A_t_times_A.determinant()) == number(0))
-    Assert(false, ExcSingular()) else
+    Assert(false, ExcSingular());
+  else
     {
       A_t_times_A_inv.invert(A_t_times_A);
       A_t_times_A_inv.mmult(left_inv, A_t);
@@ -1652,7 +1653,8 @@ FullMatrix<number>::right_invert(const FullMatrix<number2> &A)
   A_t.Tadd(A, 1);
   A.mmult(A_times_A_t, A_t);
   if (number(A_times_A_t.determinant()) == number(0))
-    Assert(false, ExcSingular()) else
+    Assert(false, ExcSingular());
+  else
     {
       A_times_A_t_inv.invert(A_times_A_t);
       A_t.mmult(right_inv, A_times_A_t_inv);
index d4ef78f35752bbc824635f85940ce94f73c7c4ad..185d45a622fd408026288172e61695fe2633420b 100644 (file)
@@ -4964,11 +4964,11 @@ namespace DataOutBase
     // check against # of data sets in first patch.
     if (patches[0].points_are_available)
       {
-        AssertDimension(n_data_sets + spacedim, patches[0].data.n_rows())
+        AssertDimension(n_data_sets + spacedim, patches[0].data.n_rows());
       }
     else
       {
-        AssertDimension(n_data_sets, patches[0].data.n_rows())
+        AssertDimension(n_data_sets, patches[0].data.n_rows());
       }
 
     //---------------------
@@ -5375,11 +5375,11 @@ namespace DataOutBase
     // patches are made in write_gmv_reorder_data_vectors
     if (patches[0].points_are_available)
       {
-        AssertDimension(n_data_sets + spacedim, patches[0].data.n_rows())
+        AssertDimension(n_data_sets + spacedim, patches[0].data.n_rows());
       }
     else
       {
-        AssertDimension(n_data_sets, patches[0].data.n_rows())
+        AssertDimension(n_data_sets, patches[0].data.n_rows());
       }
 
     const char *ascii_or_binary =
index 94cc80cbdc1e4e3d967f0632b47bea5bd4850676..a7de839c6324330206533d94c7bec54c45e0d161 100644 (file)
@@ -30,7 +30,7 @@ namespace Functions
       : center(center)
       , radius(radius)
     {
-      Assert(radius > 0, ExcMessage("Radius must be positive."))
+      Assert(radius > 0, ExcMessage("Radius must be positive."));
     }
 
 
@@ -89,7 +89,7 @@ namespace Functions
       : point_in_plane(point)
       , normal(normal)
     {
-      Assert(normal.norm() > 0, ExcMessage("Plane normal must not be 0."))
+      Assert(normal.norm() > 0, ExcMessage("Plane normal must not be 0."));
     }
 
 
@@ -142,7 +142,7 @@ namespace Functions
       , max_iter(max_iter)
     {
       for (unsigned int d = 0; d < dim; ++d)
-        Assert(radii[d] > 0, ExcMessage("All radii must be positive."))
+        Assert(radii[d] > 0, ExcMessage("All radii must be positive."));
     }
 
 
index f2cd1b19c63a9840302fe8b0f35b91ecb6b11508..39f9b92f87f0bd9ce3588ee16d3a4e0ad3207a61 100644 (file)
@@ -1019,7 +1019,8 @@ namespace Utilities
       if (finalize_petscslepc)
         {
           PetscErrorCode ierr = SlepcFinalize();
-          AssertThrow(ierr == 0, SLEPcWrappers::SolverBase::ExcSLEPcError(ierr))
+          AssertThrow(ierr == 0,
+                      SLEPcWrappers::SolverBase::ExcSLEPcError(ierr));
         }
 #  else
       // or just end PETSc if we did so
index 831d4a69e4f10d33016d9597e2a7cf92401e2ac8..dcac24e43cf1d9bade21f77be74b8c1c137dbf88 100644 (file)
@@ -665,7 +665,7 @@ namespace Polynomials
             break;
           }
         default:
-          Assert(false, ExcInternalError())
+          Assert(false, ExcInternalError());
       }
 
     Assert(x != nullptr, ExcInternalError());
index 8ec6713bb72f4ef2d5b0dd0afb4e0d5c315517c5..5964e35e85a089f168c13be482af0d82cc27f01c 100644 (file)
@@ -73,7 +73,7 @@ namespace internal
       {
         Assert(false,
                ExcMessage("The number stored by this element of the "
-                          "table is not a number."))
+                          "table is not a number."));
       }
 
     return 0;
index 2cc1c893ec614dbcd8da585ec4f1b38e9e1c5d03..79cd033d14fa89aedd3515eafd14a6d8811d6ecd 100644 (file)
@@ -115,10 +115,10 @@ namespace RepartitioningPolicyTools
     Assert(
       tria_fine.all_reference_cells_are_hyper_cube(),
       ExcMessage(
-        "FirstChildPolicy is only working for pure hex meshes at the moment."))
+        "FirstChildPolicy is only working for pure hex meshes at the moment."));
 
-      const internal::CellIDTranslator<dim>
-        cell_id_translator(n_coarse_cells, n_global_levels);
+    const internal::CellIDTranslator<dim> cell_id_translator(n_coarse_cells,
+                                                             n_global_levels);
     is_level_partitions.set_size(cell_id_translator.size());
 
     for (const auto &cell : tria_fine.active_cell_iterators())
index b8d2db266fa5e8049c37d9fc8fe7ceb52f195c4e..8156890ef9012644f8b97ac13a210cdf74da5b6d 100644 (file)
@@ -153,7 +153,7 @@ namespace parallel
         }
       else
         {
-          AssertThrow(false, ExcInternalError())
+          AssertThrow(false, ExcInternalError());
         }
 
       // do not partition multigrid levels if user is
index 768d0cddbab6c472c052329114f52859bbbc207d..38ca81c57b6fda546091316f3ac23e17e06776cc 100644 (file)
@@ -3271,7 +3271,7 @@ namespace internal
             Assert(Utilities::MPI::this_mpi_process(tr->get_communicator()) ==
                      this->dof_handler->get_triangulation()
                        .locally_owned_subdomain(),
-                   ExcInternalError())
+                   ExcInternalError());
 
             // gather new numbers among processors into one vector
             {
index f134f3181b4be0b5ff924bcc1d9cad7b87b44760..7e8aafdef6ed72162d090b350ec734f0ab44369b 100644 (file)
@@ -2225,10 +2225,9 @@ namespace DoFTools
       // matrix, we assume that for a 0* rotation we would have to build the
       // identity matrix
 
-      Assert(matrix.m() == spacedim, ExcInternalError())
+      Assert(matrix.m() == spacedim, ExcInternalError());
 
-        Quadrature<dim - 1>
-          quadrature(fe.get_unit_face_support_points(face_no));
+      Quadrature<dim - 1> quadrature(fe.get_unit_face_support_points(face_no));
 
       // have an array that stores the location of each vector-dof tuple we want
       // to rotate.
index 97b8e8d8ec19cd21e15e36e51263afbc18105b64..40e3b68e26ee5faafaa84f037c6bac1e5bf6a344 100644 (file)
@@ -1040,7 +1040,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_values(
             (mapping_kind == mapping_raviart_thomas) ||
             (mapping_kind == mapping_nedelec))))
         {
-          Assert(false, ExcNotImplemented())
+          Assert(false, ExcNotImplemented());
         }
     }
 }
@@ -1724,7 +1724,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_face_values(
       // third derivatives are not implemented
       if (fe_data.update_each & update_3rd_derivatives)
         {
-          Assert(false, ExcNotImplemented())
+          Assert(false, ExcNotImplemented());
         }
     }
 }
@@ -2397,7 +2397,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_subface_values(
       // third derivatives are not implemented
       if (fe_data.update_each & update_3rd_derivatives)
         {
-          Assert(false, ExcNotImplemented())
+          Assert(false, ExcNotImplemented());
         }
     }
 }
index 90ee15377d0672dad0a2831e74e7e3bd991d1b37..c4c33b3a1ff1dab81891801c620070d4cdcdd548 100644 (file)
@@ -2650,11 +2650,11 @@ namespace GridGenerator
           epsilon = std::min(epsilon, 0.01 * delta[i][i]);
         Assert(epsilon > 0,
                ExcMessage(
-                 "The distance between corner points must be positive."))
+                 "The distance between corner points must be positive."));
 
-          // actual code is external since
-          // 1-D is different from 2/3d.
-          colorize_subdivided_hyper_rectangle(tria, p1, p2, epsilon);
+        // actual code is external since
+        // 1-D is different from 2/3d.
+        colorize_subdivided_hyper_rectangle(tria, p1, p2, epsilon);
       }
   }
 
@@ -5125,9 +5125,9 @@ namespace GridGenerator
   {
     AssertThrow(n_rotate_middle_square < 4,
                 ExcMessage("The number of rotation by pi/2 of the right square "
-                           "must be in the half-open range [0,4)."))
+                           "must be in the half-open range [0,4)."));
 
-      constexpr unsigned int dim = 2;
+    constexpr unsigned int dim = 2;
 
     const unsigned int         n_cells = 5;
     std::vector<CellData<dim>> cells(n_cells);
@@ -8706,7 +8706,7 @@ namespace GridGenerator
       }
     else
       {
-        AssertThrow(false, ExcNotImplemented())
+        AssertThrow(false, ExcNotImplemented());
       }
   }
 } // namespace GridGenerator
index 0fb44268a9ab09d02c60a23c8bb560624d19ab27..6abda211d979adf9d27935bd01065536bd0d5d5b 100644 (file)
@@ -1403,7 +1403,7 @@ namespace GridTools
               (std::lower_bound(edge_list.begin(), edge_list.end(), e) -
                edge_list.begin());
             Assert(edge_indices[l] < edge_list.size(), ExcInternalError());
-            Assert(edge_list[edge_indices[l]] == e, ExcInternalError())
+            Assert(edge_list[edge_indices[l]] == e, ExcInternalError());
           }
       }
 
index e3a004a552bc0e110432839537707611a6df625b..9db1fabe33da85c914995cf2d43e30d4f37c9d94 100644 (file)
@@ -13174,7 +13174,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented())
+        Assert(false, ExcNotImplemented());
       }
   }
 } // namespace
@@ -13214,7 +13214,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented())
+        Assert(false, ExcNotImplemented());
       }
   }
 } // namespace
@@ -13254,7 +13254,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented())
+        Assert(false, ExcNotImplemented());
       }
   }
 } // namespace
index 78c3b6927ce95b6ac55e4ac563f97cc0025e4e5b..8967c581e3340248deb9a2e6f1bf77797cb8a462 100644 (file)
@@ -783,7 +783,8 @@ namespace PETScWrappers
     {
       Assert(false,
              ExcMessage("You can't ask a complex value "
-                        "whether it is non-negative.")) return true;
+                        "whether it is non-negative."));
+      return true;
     }
   } // namespace internal
 
index 65fdb2c792e4c35953c89b4f39540684e8b23da3..11c2b56d86ce70c558ef48cb7f000d56f93f73de 100644 (file)
@@ -679,11 +679,10 @@ namespace SparsityTools
                               "component, but as stated in the documentation "
                               "we only want to reorder such graphs if no "
                               "starting indices are given. The function was "
-                              "called with starting indices, however."))
+                              "called with starting indices, however."));
 
-              next_round_dofs.push_back(
-                internal::find_unnumbered_starting_index(sparsity,
-                                                         new_indices));
+            next_round_dofs.push_back(
+              internal::find_unnumbered_starting_index(sparsity, new_indices));
           }
 
 
index 923e61396b80f38e5ec7583fa66064c30dd85b13..940cd725f563d71e95cfafd65626555e07746cec 100644 (file)
@@ -336,7 +336,7 @@ DataOutFaces<dim, spacedim>::build_patches(const unsigned int n_subdivisions)
     Assert(false,
            ExcMessage("The DataOutFaces class can currently not be "
                       "used on meshes that do not have the same cell type "
-                      "throughout."))
+                      "throughout."));
 }
 
 
index ef123697e434b09c058636dd13bd6d703ecc4fee..fca5e46be28edc8d0cdde73441721256d913c9e8 100644 (file)
@@ -37,10 +37,9 @@ check()
   const double d  = p1.distance(p2);
   const double d2 = p1.distance_square(p2);
 
-  AssertThrow(std::abs(d - std::sqrt(d2)) < 1e-10, ExcInternalError())
+  AssertThrow(std::abs(d - std::sqrt(d2)) < 1e-10, ExcInternalError());
 
-      deallog
-    << "Ok" << std::endl;
+  deallog << "Ok" << std::endl;
 }
 
 int
index 843152b8ad4769d5dc06b78fc1ef8e6c856fccb6..49c806dcfe0a81182b4e17fa935312baf7669b5f 100644 (file)
@@ -108,33 +108,35 @@ test()
 
         fe_val.get_function_values(interpolant, values);
         fe_val_m.get_function_values(interpolant, values_m);
-        Assert(values[0] == values_m[0], ExcInternalError())
+        Assert(values[0] == values_m[0], ExcInternalError());
 
-          for (const unsigned int f : GeometryInfo<dim>::face_indices())
-        {
-          fe_f_val.reinit(cell, f);
-          fe_f_val_m.reinit(cell, f);
+        for (const unsigned int f : GeometryInfo<dim>::face_indices())
+          {
+            fe_f_val.reinit(cell, f);
+            fe_f_val_m.reinit(cell, f);
 
-          fe_f_val.get_function_values(interpolant, values);
-          fe_f_val_m.get_function_values(interpolant, values_m);
-          Assert(values[0] == values_m[0], ExcInternalError())
+            fe_f_val.get_function_values(interpolant, values);
+            fe_f_val_m.get_function_values(interpolant, values_m);
+            Assert(values[0] == values_m[0], ExcInternalError());
 
             // Also check the Jacobian with FESubfaceValues
             if (cell->at_boundary(f) == false &&
                 cell->neighbor(f)->level() < cell->level())
-          {
-            fe_subf_val.reinit(cell->neighbor(f),
-                               cell->neighbor_face_no(f),
-                               cell->neighbor_of_coarser_neighbor(f).second);
-            fe_subf_val_m.reinit(cell->neighbor(f),
-                                 cell->neighbor_face_no(f),
-                                 cell->neighbor_of_coarser_neighbor(f).second);
-
-            fe_subf_val.get_function_values(interpolant, values);
-            fe_subf_val_m.get_function_values(interpolant, values_m);
-            Assert(values[0] == values_m[0], ExcInternalError())
+              {
+                fe_subf_val.reinit(
+                  cell->neighbor(f),
+                  cell->neighbor_face_no(f),
+                  cell->neighbor_of_coarser_neighbor(f).second);
+                fe_subf_val_m.reinit(
+                  cell->neighbor(f),
+                  cell->neighbor_face_no(f),
+                  cell->neighbor_of_coarser_neighbor(f).second);
+
+                fe_subf_val.get_function_values(interpolant, values);
+                fe_subf_val_m.get_function_values(interpolant, values_m);
+                Assert(values[0] == values_m[0], ExcInternalError());
+              }
           }
-        }
       }
     deallog << "OK" << std::endl;
   }
index b21519687475e913e8aef07de5b2274c01e58d3c..edca6c9a6e6903264f155e0d536b5e5605b2dae3 100644 (file)
@@ -248,7 +248,9 @@ namespace StokesClass
                     "did not converge to a tolerance of " +
                     Utilities::to_string(solver_control.tolerance()) +
                     ". It reported the following error:\n\n") +
-                  exc.what())) else throw QuietException();
+                  exc.what()));
+            else
+              throw QuietException();
           }
         dst.block(1) *= -1.0;
       }
index c0800bff720b3ba9ab7b054e903674c2b7e1da31..6d59272d0557a71b5bb120c351ab5fb8aba1d840 100644 (file)
@@ -105,12 +105,13 @@ test()
         {
           AssertThrow(p->row() == 0, ExcInternalError());
           if (p->column() == 0)
-            AssertThrow(p->value() == 0.1,
-                        ExcInternalError()) else if (p->column() == 2)
-              AssertThrow(p->value() == 0.2, ExcInternalError()) else
-              // well, we didn't write here, so the only thing that
-              // should be in there is a zero
-              AssertThrow(p->value() == 0.0, ExcInternalError());
+            AssertThrow(p->value() == 0.1, ExcInternalError());
+          else if (p->column() == 2)
+            AssertThrow(p->value() == 0.2, ExcInternalError());
+          else
+            // well, we didn't write here, so the only thing that
+            // should be in there is a zero
+            AssertThrow(p->value() == 0.0, ExcInternalError());
         }
     }
   else
@@ -121,10 +122,11 @@ test()
         {
           AssertThrow(p->row() == 2, ExcInternalError());
           if (p->column() == 3)
-            AssertThrow(p->value() == 0.3, ExcInternalError()) else
-              // well, we didn't write here, so the only thing that
-              // should be in there is a zero
-              AssertThrow(p->value() == 0.0, ExcInternalError());
+            AssertThrow(p->value() == 0.3, ExcInternalError());
+          else
+            // well, we didn't write here, so the only thing that
+            // should be in there is a zero
+            AssertThrow(p->value() == 0.0, ExcInternalError());
         }
     }
 
@@ -141,12 +143,13 @@ test()
         {
           AssertThrow(p->row() == 0, ExcInternalError());
           if (p->column() == 0)
-            AssertThrow(p->value() == 0.1,
-                        ExcInternalError()) else if (p->column() == 2)
-              AssertThrow(p->value() == 0.2, ExcInternalError()) else
-              // well, we didn't write here, so the only thing that
-              // should be in there is a zero
-              AssertThrow(p->value() == 0.0, ExcInternalError());
+            AssertThrow(p->value() == 0.1, ExcInternalError());
+          else if (p->column() == 2)
+            AssertThrow(p->value() == 0.2, ExcInternalError());
+          else
+            // well, we didn't write here, so the only thing that
+            // should be in there is a zero
+            AssertThrow(p->value() == 0.0, ExcInternalError());
         }
     }
   else
@@ -158,10 +161,11 @@ test()
         {
           AssertThrow(p->row() == 2, ExcInternalError());
           if (p->column() == 3)
-            AssertThrow(p->value() == 0.3, ExcInternalError()) else
-              // well, we didn't write here, so the only thing that
-              // should be in there is a zero
-              AssertThrow(p->value() == 0.0, ExcInternalError());
+            AssertThrow(p->value() == 0.3, ExcInternalError());
+          else
+            // well, we didn't write here, so the only thing that
+            // should be in there is a zero
+            AssertThrow(p->value() == 0.0, ExcInternalError());
         }
     }
 
@@ -175,12 +179,13 @@ test()
         {
           AssertThrow(p->row() == 0, ExcInternalError());
           if (p->column() == 0)
-            AssertThrow(p->value() == 108,
-                        ExcInternalError()) else if (p->column() == 2)
-              AssertThrow(p->value() == 0.2, ExcInternalError()) else
-              // well, we didn't write here, so the only thing that
-              // should be in there is a zero
-              AssertThrow(p->value() == 0.0, ExcInternalError());
+            AssertThrow(p->value() == 108, ExcInternalError());
+          else if (p->column() == 2)
+            AssertThrow(p->value() == 0.2, ExcInternalError());
+          else
+            // well, we didn't write here, so the only thing that
+            // should be in there is a zero
+            AssertThrow(p->value() == 0.0, ExcInternalError());
         }
     }
   else
@@ -191,10 +196,11 @@ test()
         {
           AssertThrow(p->row() == 2, ExcInternalError());
           if (p->column() == 3)
-            AssertThrow(p->value() == 42, ExcInternalError()) else
-              // well, we didn't write here, so the only thing that
-              // should be in there is a zero
-              AssertThrow(p->value() == 0.0, ExcInternalError());
+            AssertThrow(p->value() == 42, ExcInternalError());
+          else
+            // well, we didn't write here, so the only thing that
+            // should be in there is a zero
+            AssertThrow(p->value() == 0.0, ExcInternalError());
         }
     }
 
index 34a3a5bcafded61c1bc372c4b2bef3e31ef0e6d5..2edf3d4a8eb43884777fc2cafdb03166d1b24b66 100644 (file)
@@ -248,7 +248,9 @@ namespace StokesClass
                     "did not converge to a tolerance of " +
                     Utilities::to_string(solver_control.tolerance()) +
                     ". It reported the following error:\n\n") +
-                  exc.what())) else throw QuietException();
+                  exc.what()));
+            else
+              throw QuietException();
           }
         dst.block(1) *= -1.0;
       }
index b40d5226d6b29634bd88ac29770e29bdfa4317ba..27f0091ccf1b141dac18fa22376b7d94e04badc4 100644 (file)
@@ -51,7 +51,7 @@ check_get_normals(
 {
   const std::vector<Point<dim>>     &points  = quadrature.get_points();
   const std::vector<Tensor<1, dim>> &normals = quadrature.get_normal_vectors();
-  AssertThrow(points.size() == normals.size(), ExcInternalError())
+  AssertThrow(points.size() == normals.size(), ExcInternalError());
 }
 
 
index 3451766065c7daf2415a167cd6ecf5271d65b961..e4c972c1a744b68dafb6a64b523ffe53097d7007 100644 (file)
@@ -249,7 +249,9 @@ namespace StokesClass
                     "did not converge to a tolerance of " +
                     Utilities::to_string(solver_control.tolerance()) +
                     ". It reported the following error:\n\n") +
-                  exc.what())) else throw QuietException();
+                  exc.what()));
+            else
+              throw QuietException();
           }
         dst.block(1) *= -1.0;
       }
index 0536d0dec660663259ed0232e29ce47ddae9dbe1..a3cdf66355b0cf7b3f74bdc92f9f6e3cb8805534 100644 (file)
@@ -63,7 +63,7 @@ compare_meshes(parallel::shared::Triangulation<dim>      &shared_tria,
     {
       AssertThrow(shared_map[it->first] == it->second,
                   ExcMessage(
-                    "Not all CellIds map to correct level subdomain_ids."))
+                    "Not all CellIds map to correct level subdomain_ids."));
     }
 
 
@@ -88,14 +88,14 @@ compare_meshes(parallel::shared::Triangulation<dim>      &shared_tria,
     {
       if (cell1->level_subdomain_id() != numbers::artificial_subdomain_id)
         Assert(p4est_known_cells.find(cell1->id()) != p4est_known_cells.end(),
-               ExcMessage("Cell not known by processor."))
+               ExcMessage("Cell not known by processor."));
     }
   cell2 = p4est_tria.begin(), endc2 = p4est_tria.end();
   for (; cell2 != endc2; ++cell2)
     {
       if (cell2->level_subdomain_id() != numbers::artificial_subdomain_id)
         Assert(shared_known_cells.find(cell2->id()) != shared_known_cells.end(),
-               ExcMessage("Cell not known by processor."))
+               ExcMessage("Cell not known by processor."));
     }
 }
 
index 50cc2130c713ce5aa61ddad25bc132ef866b2cf0..4ea3bf1d4d2fd57bbde3b9f6cefae654896df07a 100644 (file)
@@ -37,10 +37,9 @@ compare_meshes(parallel::shared::Triangulation<dim>      &shared_tria,
 {
   AssertThrow(shared_tria.n_locally_owned_active_cells() ==
                 p4est_tria.n_locally_owned_active_cells(),
-              ExcMessage("Subdomains are of different sizes."))
+              ExcMessage("Subdomains are of different sizes."));
 
-    std::map<CellId, unsigned int>
-                                 shared_map;
+  std::map<CellId, unsigned int> shared_map;
   std::map<CellId, unsigned int> p4est_map;
 
   typename Triangulation<dim>::active_cell_iterator cell1 = shared_tria
@@ -66,7 +65,7 @@ compare_meshes(parallel::shared::Triangulation<dim>      &shared_tria,
        ++it)
     {
       AssertThrow(shared_map[it->first] == it->second,
-                  ExcMessage("Not all CellIds map to correct subdomain_ids."))
+                  ExcMessage("Not all CellIds map to correct subdomain_ids."));
     }
 }
 
index c7434286b283886a719470b22451ec40f8cc5ceb..5f392f164e5846d6925ebf35db0c9a1b7939b233 100644 (file)
@@ -30,7 +30,7 @@ template <int dim>
 void
 test(const unsigned int)
 {
-  AssertThrow(false, ExcNotImplemented())
+  AssertThrow(false, ExcNotImplemented());
 }
 
 template <>
index c1f04ccb43e603aa863872735e1ce93a86063a95..cdf68f9611d884181f1de49616036e1b64adc4af 100644 (file)
@@ -123,7 +123,7 @@ namespace dealii
         }
       else
         {
-          AssertThrow(false, ExcNotImplemented())
+          AssertThrow(false, ExcNotImplemented());
         }
     }
 
@@ -269,7 +269,7 @@ namespace dealii
         }
       else
         {
-          AssertThrow(false, ExcNotImplemented())
+          AssertThrow(false, ExcNotImplemented());
         }
     }
 
@@ -373,7 +373,7 @@ namespace dealii
         }
       else
         {
-          AssertThrow(false, ExcNotImplemented())
+          AssertThrow(false, ExcNotImplemented());
         }
     }
 

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.