]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use DEAL_II_UNREACHABLE() in include/ and source/.
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 1 Feb 2024 04:44:11 +0000 (21:44 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Tue, 6 Feb 2024 15:31:16 +0000 (08:31 -0700)
82 files changed:
include/deal.II/base/geometry_info.h
include/deal.II/base/hdf5.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/table.h
include/deal.II/base/table_handler.h
include/deal.II/base/utilities.h
include/deal.II/cgal/triangulation.h
include/deal.II/cgal/utilities.h
include/deal.II/distributed/cell_data_transfer.templates.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/fe/fe_data.h
include/deal.II/fe/fe_values_views.h
include/deal.II/fe/mapping_q_internal.h
include/deal.II/grid/manifold.h
include/deal.II/grid/reference_cell.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/sparse_vanka.templates.h
include/deal.II/lac/tridiagonal_matrix.h
include/deal.II/matrix_free/cuda_matrix_free.templates.h
include/deal.II/matrix_free/evaluation_kernels_face.h
include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h
include/deal.II/matrix_free/fe_point_evaluation.h
include/deal.II/matrix_free/tensor_product_kernels.h
include/deal.II/meshworker/integration_info.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/vector_tools_boundary.templates.h
include/deal.II/numerics/vector_tools_project.templates.h
include/deal.II/trilinos/nox.templates.h
source/base/data_out_base.cc
source/base/hdf5.cc
source/base/index_set.cc
source/base/parameter_handler.cc
source/base/polynomial.cc
source/base/polynomial_space.cc
source/base/qprojector.cc
source/base/quadrature_lib.cc
source/base/table_handler.cc
source/cgal/surface_mesh.cc
source/distributed/cell_weights.cc
source/distributed/grid_refinement.cc
source/distributed/shared_tria.cc
source/distributed/solution_transfer.cc
source/distributed/tria.cc
source/dofs/dof_accessor.cc
source/dofs/dof_handler.cc
source/dofs/dof_renumbering.cc
source/dofs/dof_tools_constraints.cc
source/fe/fe_hermite.cc
source/fe/fe_q_base.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_system.cc
source/fe/fe_values.cc
source/fe/fe_values_views_internal.cc
source/fe/fe_wedge_p.cc
source/fe/mapping.cc
source/fe/mapping_q.cc
source/grid/grid_generator.cc
source/grid/grid_in.cc
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/grid_tools_topology.cc
source/grid/manifold_lib.cc
source/grid/persistent_tria.cc
source/grid/reference_cell.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/hp/refinement.cc
source/lac/scalapack.cc
source/non_matching/fe_values.cc
source/numerics/data_out_stack.cc
source/numerics/histogram.cc
source/numerics/solution_transfer.cc
source/numerics/time_dependent.cc
source/opencascade/manifold_lib.cc
source/particles/particle_handler.cc
source/sundials/kinsol.cc

index daf0d42c6183fada955c2b634684e63e0d1b38ec..c56482e72a7e9f85fc4500f7025143370f594020 100644 (file)
@@ -2747,7 +2747,7 @@ template <int dim>
 inline RefinementCase<dim>
 RefinementCase<dim>::cut_axis(const unsigned int)
 {
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return static_cast<std::uint8_t>(-1);
 }
 
@@ -3099,7 +3099,7 @@ GeometryInfo<2>::cell_to_child_coordinates(const Point<2>         &p,
         point -= unit_cell_vertex(child_index);
         break;
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
   return point;
@@ -3172,7 +3172,7 @@ GeometryInfo<3>::cell_to_child_coordinates(const Point<3>         &p,
         point -= unit_cell_vertex(child_index);
         break;
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
   return point;
@@ -3275,7 +3275,7 @@ GeometryInfo<3>::child_to_cell_coordinates(const Point<3>         &p,
         point *= 0.5;
         break;
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
   return point;
@@ -3309,7 +3309,7 @@ GeometryInfo<2>::child_to_cell_coordinates(const Point<2>         &p,
         point *= 0.5;
         break;
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
   return point;
@@ -3625,7 +3625,7 @@ GeometryInfo<2>::subface_ratio(const internal::SubfaceCase<2> &subface_case,
       default:
         // there should be no
         // cases left
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
         break;
     }
 
@@ -3682,7 +3682,7 @@ GeometryInfo<3>::subface_ratio(const internal::SubfaceCase<3> &subface_case,
       default:
         // there should be no
         // cases left
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
         break;
     }
 
index dc5bad3af38e0d7cebb4ba27b0c41aa536a0cec0..9ab994f8170c168de57b409e9fcf59e69940edf0 100644 (file)
@@ -1352,7 +1352,7 @@ namespace HDF5
         }
 
       // The function should not reach this point
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
       return {};
     }
 
index 3ba5c9abd87971b04f7ade3c66643959349cb382..9f12be21fdd40db45a1ce16ed3d3b0c49d349c9f 100644 (file)
@@ -304,7 +304,7 @@ namespace internal
                     previous_indices[2],
                     new_index};
           default:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             return {};
         }
     }
@@ -2067,7 +2067,7 @@ namespace internal
                     return dim + c;
 
               // should never get here:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
               return 0;
             }
         }
@@ -2543,7 +2543,7 @@ namespace internal
                   return {d, e};
 
             // should never get here:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             return {0, 0};
         }
     }
index 5c894431895e8cb09328c8853c8a8b0aaeaeb7ce..31ff756a81473c3acfdc4e655b89f1dd7dba10da 100644 (file)
@@ -2873,7 +2873,7 @@ namespace MatrixTableIterators
           case Storage::column_major:
             return linear_index % container->n_rows();
           default:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
         }
       return {};
     }
@@ -2892,7 +2892,7 @@ namespace MatrixTableIterators
           case Storage::column_major:
             return linear_index / container->n_rows();
           default:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
         }
       return {};
     }
index 1e019f7e38a022e78886619ba495dffb3e88ce37..b354a893fa16d262bae576c1da324ee7092509bc 100644 (file)
@@ -875,7 +875,7 @@ namespace internal
         ar &c              &p;
       }
     else
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
   }
 
 
@@ -934,7 +934,7 @@ namespace internal
           }
 
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
       }
   }
 } // namespace internal
index 697fc210547edbb0c356618b4d40cb99d7fd7da1..ac56967ac101931ec1a456105cf41a196b1c590c 100644 (file)
@@ -1105,7 +1105,7 @@ namespace Utilities
                   // somehow? that
                   // shouldn't have
                   // happened
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
               }
           }
 
@@ -1179,7 +1179,7 @@ namespace Utilities
                                                   std::vector<char> &)
     {
       // We shouldn't get here:
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
     }
 
 
@@ -1269,7 +1269,7 @@ namespace Utilities
       T &)
     {
       // We shouldn't get here:
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
     }
 
 
index 269b4886f20b9e0e71c559b35c3462413f7d8437..bbfef455335df237e5444dac2a10940741feb73d 100644 (file)
@@ -388,7 +388,7 @@ namespace CGALWrappers
             }
         else
           {
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
           }
       }
     else if constexpr (decltype(has_cells(cgal_triangulation)){})
@@ -439,7 +439,7 @@ namespace CGALWrappers
             }
         else
           {
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
           }
       }
     dealii_triangulation.create_triangulation(vertices, cells, subcell_data);
index 08928415be9e43932689c9db7c6c4cb88b1af4b0..63751b0e65d1e15946ffc667ed91908a0d2b0b28 100644 (file)
@@ -593,7 +593,7 @@ namespace CGALWrappers
       }
     else
       {
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
       }
   }
 
index 2d07185618e2a6cbdc815c19ade3c12d904dd4fb..3a7691810c19bdf3f8db1164685246a759b48158 100644 (file)
@@ -286,7 +286,7 @@ namespace parallel
                 }
 
               default:
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
                 break;
             }
         }
@@ -357,7 +357,7 @@ namespace parallel
               }
 
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
               break;
           }
     }
index 51a7868d30876eaca193524de976d684f2826abc..59f063d2fc004ae92812d8fd583cf23c1e66ccd0 100644 (file)
@@ -481,7 +481,7 @@ namespace internal
       process_object_range(dealii::DoFInvalidAccessor<structdim, dim, spacedim>,
                            const unsigned int)
       {
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
 
         return {0, 0};
       }
@@ -1177,7 +1177,7 @@ namespace internal
             vertex_index,
             fe_index,
             [](const auto d) {
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
               return d;
             },
             std::integral_constant<int, 0>(),
index 0fddc49f1abd30ce8811e0bf69caffd7839e3e77..99c87db2612d09f9024b72f17e053e1c35f4f6b8 100644 (file)
@@ -765,7 +765,7 @@ namespace FiniteElementDomination
 
         default:
           // shouldn't get here
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
       }
 
     return neither_element_dominates;
@@ -891,7 +891,7 @@ FiniteElementData<dim>::n_dofs_per_object(const unsigned int i) const
       case 3:
         return n_dofs_per_hex();
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
   return numbers::invalid_unsigned_int;
 }
index 868ad4b99a9d29a6d16449cc9464416d356fdb2d..9afe26be206b050fca774a25d6c6e3a2113320c2 100644 (file)
@@ -2459,7 +2459,7 @@ namespace FEValuesViews
             }
         }
     // should not end up here
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
     return curl_type();
   }
 
index 5bde81b124deccd2e8b35ac2562b6f6c131bb0de..3db783ad85c24be9965eae961fa7a91647f65d6a 100644 (file)
@@ -178,7 +178,7 @@ namespace internal
         }
       // bogus return to placate compiler. It should not be possible to get
       // here.
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
       return {std::numeric_limits<double>::quiet_NaN(),
               std::numeric_limits<double>::quiet_NaN()};
     }
@@ -193,7 +193,7 @@ namespace internal
       const Point<spacedim> & /*p*/)
     {
       // It should not be possible to get here
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
       return {std::numeric_limits<double>::quiet_NaN(),
               std::numeric_limits<double>::quiet_NaN(),
               std::numeric_limits<double>::quiet_NaN()};
index 64ee20410ac13e91768e9c0ba70afece4d75c6ae..53b8cf42520495b2f54ea857b3dd6a11cdf6a457 100644 (file)
@@ -1254,7 +1254,7 @@ namespace Manifolds
           }
           break;
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           break;
       }
     return points_weights;
index e159dc9c00ceac83e8efb480832601100c6c87bd..0cf6bc98c8dd3b5c65dd7050da1eab846eecaf3d 100644 (file)
@@ -2204,7 +2204,7 @@ ReferenceCell::d_linear_shape_function(const Point<dim>  &xi,
               case 2:
                 return xi[std::min(1, dim - 1)];
               default:
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
         }
       // see also BarycentricPolynomials<3>::compute_value
@@ -2222,7 +2222,7 @@ ReferenceCell::d_linear_shape_function(const Point<dim>  &xi,
               case 3:
                 return xi[std::min(2, dim - 1)];
               default:
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
         }
       // see also ScalarLagrangePolynomialPyramid::compute_value()
@@ -2290,7 +2290,7 @@ ReferenceCell::d_linear_shape_function_gradient(const Point<dim>  &xi,
             case 2:
               return Point<dim>(+0.0, +1.0);
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
       default:
         DEAL_II_NOT_IMPLEMENTED();
@@ -2598,7 +2598,7 @@ ReferenceCell::n_face_orientations(const unsigned int face_no) const
   else if (face_reference_cell(face_no) == ReferenceCells::Triangle)
     return 6;
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return numbers::invalid_unsigned_int;
 }
 
index 4a0c59401bdee2b4f1361bbd0381a48951cd4be5..600dfbf5a8fcec9c5894c4ccfdddcee00a30ed46 100644 (file)
@@ -117,13 +117,13 @@ namespace internal
         void
         operator++() const
         {
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
         void
         operator--() const
         {
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
       };
     };
index 026e698a2059d8e00e1b93e917f63251248c48e7..307a7b74de4d4332a0692f23fb5d567623b6c80f 100644 (file)
@@ -365,7 +365,7 @@ TriaAccessorBase<structdim, dim, spacedim>::objects() const
   if (structdim == 2 && dim > 2)
     return this->tria->faces->quads;
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 
   return this->tria->levels[this->present_level]->cells;
 }
@@ -867,7 +867,7 @@ namespace internal
         const unsigned int,
         const unsigned char)
       {
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
       }
 
 
@@ -893,7 +893,7 @@ namespace internal
                            const unsigned int,
                            const bool)
       {
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
       }
 
 
@@ -905,7 +905,7 @@ namespace internal
       {
         // quads in 2d have no
         // non-standard orientation
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
       }
 
 
@@ -994,7 +994,7 @@ namespace internal
       static std::array<unsigned int, 1>
       get_line_indices_of_cell(const TriaAccessor<1, dim, spacedim> &)
       {
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
         return {};
       }
 
@@ -1107,7 +1107,7 @@ namespace internal
       static std::array<unsigned char, 1>
       get_line_orientations_of_cell(const TriaAccessor<1, dim, spacedim> &)
       {
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
         return {};
       }
 
@@ -2953,7 +2953,7 @@ TriaAccessor<0, 1, spacedim>::copy_from(
   // We cannot convert from TriaAccessorBase to
   // TriaAccessor<0,1,spacedim> because the latter is not derived from
   // the former. We should never get here.
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
@@ -3806,7 +3806,7 @@ CellAccessor<3>::subface_case(const unsigned int face_no) const
       case RefinementCase<3>::cut_xy:
         return dealii::internal::SubfaceCase<3>::case_xy;
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
   // we should never get here
   return dealii::internal::SubfaceCase<3>::case_none;
index f0cb6f49b86f33fd729fb331acc866117add29c2..6e5437b821288196e1b967ceb68e661a81080390 100644 (file)
@@ -1071,7 +1071,7 @@ BlockDynamicSparsityPattern::column_number(const size_type    row,
       block_columns += sub_objects[row_index.first][b]->n_cols();
     }
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return 0;
 }
 
index cba700b26ce7d4dec83af5f93f48d259a84d9947..3d341e42a5fe150ce8c1b5f90834deee4f26b011 100644 (file)
@@ -242,7 +242,7 @@ namespace LinearAlgebra
                                     }};
 
 #else
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
 #endif
             }
         }
index 72234c8c0559c34d05a1f2778e30e966b8086191..4ef8472bc16d2911609af081318af1eec566f5d6 100644 (file)
@@ -1682,7 +1682,7 @@ SolverGMRES<VectorType>::criterion()
 {
   // dummy implementation. this function is not needed for the present
   // implementation of gmres
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return 0;
 }
 
index e78507d94e178e77f63eae55b08ce855bd2aa352..99c2f652ed242cbb4764ea1b93ad4dca801e2de5 100644 (file)
@@ -552,7 +552,7 @@ SparseBlockVanka<number>::compute_dof_masks(
         }
 
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 }
 
index 09e59a70b545d576cea15fa2594eb015f70b269d..2791c9f919b5236b0e478d3f0d371b000b023577 100644 (file)
@@ -310,7 +310,7 @@ TridiagonalMatrix<number>::operator()(size_type i, size_type j) const
   if (j == i + 1)
     return right[i];
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return 0;
 }
 
@@ -337,7 +337,7 @@ TridiagonalMatrix<number>::operator()(size_type i, size_type j)
   if (j == i + 1)
     return right[i];
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return diagonal[0];
 }
 
index 3709471ae3b7caf48dc4ebc2a66734e41358fcc5..75e1967a5ceb833b0312f31a44e0844d2e6a5c36 100644 (file)
@@ -1141,7 +1141,7 @@ namespace CUDAWrappers
     const LinearAlgebra::CUDAWrappers::Vector<Number> &,
     LinearAlgebra::CUDAWrappers::Vector<Number> &) const
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
   }
 #endif
 } // namespace CUDAWrappers
index a4e61c773cf1a86a8245a5501ef2c5c08e85c459..6ffba4231c934c8dd774e2fb40a1efcff98620ee 100644 (file)
@@ -1034,7 +1034,7 @@ namespace internal
           // This should never happen since the FE_RaviartThomasNodal is not
           // defined for dim = 1. It prevents compiler warnings of infinite
           // recursion.
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           return;
         }
 
@@ -2859,7 +2859,7 @@ namespace internal
           {
             // We should not end up here, this should be caught by
             // FEFaceEvaluationImplGatherEvaluateSelector::supports()
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
           }
         temp1 += 3 * dofs_per_face;
       }
index 2612800ff60d24eee939bb8da8492720df588518..5dc2d9c0d551ccd30d935e17d9e9a9b9fb914407 100644 (file)
@@ -704,7 +704,7 @@ namespace internal
     {
       (void)kind;
 
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
 
       return v > 0; // should not be called
     }
index 8ff84419aa62762e5cb5dae63e9a6de9e1b0dbaf..ff197c6b4071a117e2e7934180633b4179e4baee 100644 (file)
@@ -3509,7 +3509,7 @@ FEFacePointEvaluation<n_components_, dim, spacedim, Number>::
               else if (dim == 2)
                 gradient[0] = interpolated_value[0];
               else
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
           else if (this->current_face_number / 2 == 2)
             {
@@ -3520,10 +3520,10 @@ FEFacePointEvaluation<n_components_, dim, spacedim, Number>::
                   gradient[2] = interpolated_value[dim];
                 }
               else
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
           else
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
         }
       else
         {
@@ -3700,7 +3700,7 @@ FEFacePointEvaluation<n_components_, dim, spacedim, Number>::
               else if (dim == 2)
                 gradient_in_face[0] = gradient[0];
               else
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
           else if (this->current_face_number / 2 == 2)
             {
@@ -3711,10 +3711,10 @@ FEFacePointEvaluation<n_components_, dim, spacedim, Number>::
                   gradient_in_face[1] = gradient[1];
                 }
               else
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
           else
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
 
           internal::integrate_tensor_product_value_and_gradient<
             is_linear,
index 93fb94d5da92cbc1dcf5f85fc000b1d38d87fff5..0ae8d2fa772b7ba7dfb32a2dfd469ea4b94fa688 100644 (file)
@@ -2071,7 +2071,7 @@ namespace internal
                           const Point<0, Number> &,
                           const unsigned int)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
   }
 
 
index c138615eae67fc2fecf355b07aba3f3507cfcadc..b773c7b432657f7d1d4fb6e96eb60683890e4360 100644 (file)
@@ -628,7 +628,7 @@ namespace MeshWorker
             ps->get_quadrature(),
             ps->get_update_flags());
         else
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
       }
   }
 #endif
index bdf21af886f9976e0d77a58d5f7fae7d8465c933..bb3e24d4b2855573121e02b044a52db5396f82cd 100644 (file)
@@ -597,7 +597,7 @@ namespace internal
     {
       return FineDoFHandlerViewCell(
         []() {
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           return false;
         },
         [this, cell](auto &dof_indices) {
@@ -622,16 +622,16 @@ namespace internal
     get_cell_view(const typename DoFHandler<dim>::cell_iterator &,
                   const unsigned int) const override
     {
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
 
       return FineDoFHandlerViewCell(
         []() {
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           return false;
         },
-        [](auto &) { Assert(false, ExcInternalError()); },
+        [](auto &) { DEAL_II_ASSERT_UNREACHABLE(); },
         []() {
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           return 0;
         });
     }
@@ -715,7 +715,7 @@ namespace internal
     {
       return FineDoFHandlerViewCell(
         []() {
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           return false;
         },
         [this, cell, c](auto &dof_indices) {
index 3f258ecd64d953f2fd263b770aa161d646a4d63b..74057268910ecb604ab3951ce54f8e40a5ec5314 100644 (file)
@@ -693,7 +693,7 @@ namespace internal
             return value.imag();
 
           default:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
         }
 
       return numbers::signaling_nan<double>();
@@ -1173,7 +1173,7 @@ namespace internal
       else if (actual_type == DataVectorType::type_cell_data)
         create_cell_vector(*data, vector);
       else
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
 
@@ -1926,7 +1926,7 @@ DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::
                  deduced_names.size(), dof_handler->get_fe(0).n_components()));
         break;
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
   const auto &data_component_interpretation =
@@ -2165,7 +2165,7 @@ DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::get_dataset_names()
                   }
 
                 default:
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
               }
           }
       }
index 533253009d6a7ad83259ee129369a656280dc42f..8ae9d745ec17cd247d2536b29d5995626ea4fc68 100644 (file)
@@ -1287,7 +1287,7 @@ namespace VectorTools
     {
       // dummy implementation of above function
       // for all other dimensions
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
     }
 
 
index 43fa6e6b93718f769b200462f027ba920a47261f..e3a7f38a56010c8c166281d976e4db86be3814ca 100644 (file)
@@ -397,7 +397,7 @@ namespace VectorTools
             break;
 
           default:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
         }
     }
 
index 951fb22983f546dd5153bf38a710863eb9f080af..bde8680a1a2c377368c35b1f5b5212f50478fd5b 100644 (file)
@@ -284,7 +284,7 @@ namespace TrilinosWrappers
           if (type == NOX::Abstract::Vector::NormType::MaxNorm)
             return vector->linfty_norm();
 
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
 
           return 0.0;
         }
index 83b0167bb75ede8d1b1688908638ac1cf5db5ae4..b2bc85ca59fb661fe86585ab9d0027c9ac7d4fcb 100644 (file)
@@ -1340,7 +1340,7 @@ namespace
     set_node_numbers(const unsigned int /*start*/,
                      const std::array<unsigned int, 0> & /*d1*/)
     {
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
       return {};
     }
 
@@ -2396,7 +2396,7 @@ namespace DataOutBase
     else
       // we shouldn't get here, since the parameter object should already have
       // checked that the given value is valid
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
   }
 
 
@@ -2590,7 +2590,7 @@ namespace DataOutBase
                   break;
 
                 default:
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
               }
           }
       }
@@ -3740,7 +3740,7 @@ namespace DataOutBase
                   // There aren't any other reference cells in 2d than the
                   // quadrilateral and the triangle. So whatever we got here
                   // can't be any good
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
                 // end of patch
                 out << '\n';
 
@@ -5152,7 +5152,7 @@ namespace DataOutBase
                 default:
                   // VTK doesn't support anything else than vectors with 1, 2,
                   // or 3 components
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
               }
           }
       }
@@ -5934,7 +5934,7 @@ namespace DataOutBase
 
                     default:
                       // Anything else is not yet implemented
-                      Assert(false, ExcInternalError());
+                      DEAL_II_ASSERT_UNREACHABLE();
                   }
               }
             else
@@ -5972,7 +5972,7 @@ namespace DataOutBase
                   }
                 else
                   {
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                   }
 
                 // now put the tensor into data
index c3851bbc696976c4552e5d9dd085d8c3b40915e4..3c5e35ad6272062cd19e106dcfa110aa2b879dc2 100644 (file)
@@ -233,12 +233,12 @@ namespace HDF5
           return std::string("H5D_MPIO_CONTIGUOUS_COLLECTIVE");
           break;
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           return std::string("Internal error");
           break;
       }
     // The function should not reach this line.
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
     return std::string("Internal error");
   }
 
@@ -356,7 +356,7 @@ namespace HDF5
           Assert(*hdf5_reference >= 0, ExcMessage("Error at H5Gcreate2"));
           break;
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           break;
       }
   }
@@ -467,7 +467,7 @@ namespace HDF5
           Assert(*hdf5_reference >= 0, ExcMessage("Error at H5Fcreate"));
           break;
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           break;
       }
 
index 590a814b4a31d5a76e01ceb4940d0f0a8712b943..19d08bd7dec72e8bc924ca0912ab7d53f96a04ee 100644 (file)
@@ -406,7 +406,7 @@ IndexSet::get_view(const IndexSet &mask) const
                                           (own_it->end - own_it->begin));
               }
             else
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
 
       // We considered the overlap of these two intervals. It may of course
       // be that one of them overlaps with another one, but that can only
index f17d3af78b89fb28e81457f0b838582559c74536..e7da93089bdd0a64dde21fca6ef8c5f93a4f4007 100644 (file)
@@ -165,7 +165,7 @@ namespace
                 c = 15 * 16;
                 break;
               default:
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
           switch (s[i + 2])
             {
@@ -218,7 +218,7 @@ namespace
                 c += 15;
                 break;
               default:
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
 
           u.push_back(static_cast<char>(c));
index 68261db079f8fb7f296dad88c91f647af9c9deb4..d2f8717dda605dc0edcddb9d886d647642a2c44e 100644 (file)
@@ -650,7 +650,7 @@ namespace Polynomials
             break;
           }
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
       }
 
     Assert(x != nullptr, ExcInternalError());
index d99890486bec20c10b8b06af1ad72e0e3d26ff96..a01b03a5239408da80eaea90cb15df71e187846b 100644 (file)
@@ -74,7 +74,7 @@ PolynomialSpace<2>::compute_index(const unsigned int i) const
     else
       k += n_1d - iy;
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return {{numbers::invalid_unsigned_int, numbers::invalid_unsigned_int}};
 }
 
@@ -104,7 +104,7 @@ PolynomialSpace<3>::compute_index(const unsigned int i) const
       else
         k += n_1d - iy - iz;
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return {{numbers::invalid_unsigned_int, numbers::invalid_unsigned_int}};
 }
 
index 9114743a6aee254b1f660de5145b2648d8f5af02..aa9a07da5693ff81f36d23c4a2f3ea6d79e2dfa4 100644 (file)
@@ -129,7 +129,7 @@ namespace internal
               eta_translation = int(subface_no / 2) * 0.5;
               break;
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
               break;
           }
 
@@ -164,7 +164,7 @@ namespace internal
             case 7:
               return rotate(reflect(points), 8 - offset);
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
         return {};
       }
@@ -386,7 +386,7 @@ QProjector<2>::project_to_face(const ReferenceCell   &reference_cell,
               q_points[p] = Point<dim>(0, 1 - quadrature.point(p)[0]);
               break;
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
     }
   else if (reference_cell == ReferenceCells::Quadrilateral)
@@ -407,12 +407,12 @@ QProjector<2>::project_to_face(const ReferenceCell   &reference_cell,
               q_points[p] = Point<dim>(quadrature.point(p)[0], 1);
               break;
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
     }
   else
     {
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
     }
 }
 
@@ -526,7 +526,7 @@ QProjector<2>::project_to_subface(const ReferenceCell   &reference_cell,
                       Point<dim>(0.5 + quadrature.point(p)[0] / 2, 0);
                     break;
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                 }
               break;
             case 1:
@@ -541,7 +541,7 @@ QProjector<2>::project_to_subface(const ReferenceCell   &reference_cell,
                                              0.5 + quadrature.point(p)[0] / 2);
                     break;
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                 }
               break;
             case 2:
@@ -555,11 +555,11 @@ QProjector<2>::project_to_subface(const ReferenceCell   &reference_cell,
                       Point<dim>(0, 0.5 - quadrature.point(p)[0] / 2);
                     break;
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                 }
               break;
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
     }
   else if (reference_cell == ReferenceCells::Quadrilateral)
@@ -578,7 +578,7 @@ QProjector<2>::project_to_subface(const ReferenceCell   &reference_cell,
                       Point<dim>(0, quadrature.point(p)[0] / 2 + 0.5);
                     break;
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                 }
               break;
             case 1:
@@ -592,7 +592,7 @@ QProjector<2>::project_to_subface(const ReferenceCell   &reference_cell,
                       Point<dim>(1, quadrature.point(p)[0] / 2 + 0.5);
                     break;
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                 }
               break;
             case 2:
@@ -606,7 +606,7 @@ QProjector<2>::project_to_subface(const ReferenceCell   &reference_cell,
                       Point<dim>(quadrature.point(p)[0] / 2 + 0.5, 0);
                     break;
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                 }
               break;
             case 3:
@@ -620,17 +620,17 @@ QProjector<2>::project_to_subface(const ReferenceCell   &reference_cell,
                       Point<dim>(quadrature.point(p)[0] / 2 + 0.5, 1);
                     break;
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                 }
               break;
 
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
     }
   else
     {
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
     }
 }
 
@@ -1408,7 +1408,7 @@ QProjector<dim>::DataSetDescriptor::face(const ReferenceCell &reference_cell,
         }
 
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
   return numbers::invalid_unsigned_int;
 }
@@ -1549,7 +1549,7 @@ QProjector<dim>::DataSetDescriptor::face(
         }
 
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
   return numbers::invalid_unsigned_int;
 }
index 92dc5ea6baeaccb29ef7192e272209e86fea405c..bd194c400b50283790036e9599bbdfba63620165 100644 (file)
@@ -1930,7 +1930,7 @@ QWitherdenVincentSimplex<dim>::QWitherdenVincentSimplex(
                 }
               break;
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
         break;
       case 3:
@@ -1985,7 +1985,7 @@ QWitherdenVincentSimplex<dim>::QWitherdenVincentSimplex(
                 }
               break;
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
         break;
       case 4:
@@ -2060,7 +2060,7 @@ QWitherdenVincentSimplex<dim>::QWitherdenVincentSimplex(
                 }
               break;
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
         break;
       case 5:
@@ -2279,7 +2279,7 @@ namespace
   Quadrature<dim>
   setup_qiterated_1D(const Quadrature<dim> &, const unsigned int)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
     return Quadrature<dim>();
   }
 
index 5964e35e85a089f168c13be482af0d82cc27f01c..6e577f98d565100032d02dd14484133825b3a65a 100644 (file)
@@ -275,7 +275,7 @@ TableHandler::add_column_to_supercolumn(const std::string &key,
       tex_supercaptions.insert(new_tex_supercaption);
     }
   else
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
@@ -561,7 +561,7 @@ TableHandler::write_text(std::ostream &out, const TextOutputFormat format) const
         }
 
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
 
index c9273e7f801d54987e0fc84eb4a1754688dc55c8..b5bdd406bbe3a48a6836f8398985639cd343f52a 100644 (file)
@@ -54,7 +54,7 @@ namespace
                    deal2cgal.at(face->vertex_index(2))};
       }
     else
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
 
     if (clockwise_ordering == true)
       std::reverse(indices.begin(), indices.end());
index fc3cc7bca5bb57aa923bcc061f9e1a62295cbea8..5ca5129afe5dfd18887b00f0045e3c21f1180a83 100644 (file)
@@ -208,7 +208,7 @@ namespace parallel
           break;
 
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           break;
       }
 
index afa4da231203b69f5f0be2109dc20039330f5fdd..a0aa4a32ac40e93e587eb87bc076ec233dd8d56f 100644 (file)
@@ -376,7 +376,7 @@ namespace internal
               }
             while (true);
 
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             return -1;
           }
         } // namespace RefineAndCoarsenFixedNumber
@@ -482,7 +482,7 @@ namespace internal
               }
             while (true);
 
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             return -1;
           }
         } // namespace RefineAndCoarsenFixedFraction
index 0628617b782cf6ba693e0b14b87bfea4f10613ad..84f663792cd0d5b1dedbcfc56710da1913591bd6 100644 (file)
@@ -443,7 +443,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
       partition();
       this->update_number_cache();
@@ -459,7 +459,7 @@ namespace parallel
     {
       (void)construction_data;
 
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
     }
 
 
index a5a645d12514462f41f7eaffdffcf64cc018c7f2..af20515b648af1f1b79f2f31e31820959830b967 100644 (file)
@@ -349,7 +349,7 @@ namespace parallel
                 }
 
               default:
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
                 break;
             }
         }
@@ -417,7 +417,7 @@ namespace parallel
                 }
 
               default:
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
                 break;
             }
         }
index 8834eff6ef1f7f58e2a24a348fc022bbd0f7bec6..5df934934fcc7fab7de4be5448fcc6f6e153a760 100644 (file)
@@ -1793,7 +1793,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       Assert(
@@ -1819,7 +1819,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       this->update_periodic_face_map();
@@ -1836,7 +1836,7 @@ namespace parallel
     {
       (void)construction_data;
 
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
     }
 
 
@@ -2165,7 +2165,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       // Load attached cell data, if any was stored.
@@ -2240,7 +2240,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       this->update_periodic_face_map();
@@ -2848,7 +2848,7 @@ namespace parallel
               {
                 // the underlying triangulation should not be checking for
                 // distorted cells
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
               }
           }
 
@@ -3003,7 +3003,7 @@ namespace parallel
             {
               // the underlying triangulation should not be checking for
               // distorted cells
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
             }
         }
       while (mesh_changed);
@@ -3468,7 +3468,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       // transfer data after triangulation got updated
@@ -3633,7 +3633,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       // transfer data after triangulation got updated
@@ -3919,7 +3919,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       // The range of ghost_owners might have changed so update that
@@ -3994,7 +3994,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       if (const dealii::parallel::distributed::Triangulation<dim, spacedim>
@@ -4044,7 +4044,7 @@ namespace parallel
         {
           // the underlying triangulation should not be checking for distorted
           // cells
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
         }
 
       this->update_periodic_face_map();
@@ -4321,7 +4321,7 @@ namespace parallel
                     break;
 
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                     break;
                 }
             }
index 692934bd4f7488ce80340036fa9a31bd5731af55..8ffa54426e74c90ff1e6efde501771964a19575b 100644 (file)
@@ -79,7 +79,7 @@ DoFInvalidAccessor<structdim, dim, spacedim>::dof_index(
   const unsigned int,
   const types::fe_index) const
 {
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return 0;
 }
 
@@ -92,7 +92,7 @@ DoFInvalidAccessor<structdim, dim, spacedim>::set_dof_index(
   const types::global_dof_index,
   const types::fe_index) const
 {
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
index c98c8dd0544e50c7bffcbfdbd0d840db1ceecb17..64a5b2ec93460fd5a90edbbd68b5c7c610cadf30 100644 (file)
@@ -2995,7 +2995,7 @@ DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
 void DoFHandler<dim, spacedim>::post_distributed_transfer_action()
 {
 #  ifndef DEAL_II_WITH_P4EST
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 #  else
   update_active_fe_table();
 
index c179014677ef20da40837205215f3ea04b9c25ae..8d2d1f22f03a00c29c2fd17c7b2d0177c6970648 100644 (file)
@@ -940,7 +940,7 @@ namespace DoFRenumbering
           }
 #else
         (void)tria;
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
 #endif
       }
     else
@@ -1201,7 +1201,7 @@ namespace DoFRenumbering
           }
 #else
         (void)tria;
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
 #endif
       }
     else
index a0b98bb6e6924bd8d82fd2d8f5fd3a92f53371f8..aeeacbbc260090e6a54cc738e579e5855048c3cf 100644 (file)
@@ -2766,7 +2766,7 @@ namespace DoFTools
 
                     default:
                       // we shouldn't get here
-                      Assert(false, ExcInternalError());
+                      DEAL_II_ASSERT_UNREACHABLE();
                   }
               }
             else
@@ -3059,7 +3059,7 @@ namespace DoFTools
 
                         default:
                           // we shouldn't get here
-                          Assert(false, ExcInternalError());
+                          DEAL_II_ASSERT_UNREACHABLE();
                       }
                   }
               }
index ef139d0f3a2a42329ac31cc9dbc8ab245f169a79..f15cad64964dda33066e8f9a979083069e644867 100644 (file)
@@ -262,7 +262,7 @@ namespace internal
           cell_extent = data->cell_extents[0];
         }
       else
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
 
       const unsigned int regularity      = fe_herm.get_regularity();
       const unsigned int n_dofs_per_cell = fe_herm.n_dofs_per_cell();
@@ -321,7 +321,7 @@ namespace internal
           cell_extents = data->cell_extents;
         }
       else
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
 
       const unsigned int regularity      = fe_herm.get_regularity();
       const unsigned int n_dofs_per_cell = fe_herm.n_dofs_per_cell();
@@ -395,7 +395,7 @@ namespace internal
           cell_extents = data->cell_extents;
         }
       else
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
 
       const unsigned int regularity      = fe_herm.get_regularity();
       const unsigned int n_dofs_per_cell = fe_herm.n_dofs_per_cell();
index 9d20b053bfb77ec15627a0c05640b769b1a3d7b2..eae49e57ae566898804c5b7906467b808f759992 100644 (file)
@@ -1165,7 +1165,7 @@ FE_Q_Base<dim, spacedim>::face_to_cell_index(
       switch (dim)
         {
           case 1:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             break;
 
           case 2:
@@ -1193,7 +1193,7 @@ FE_Q_Base<dim, spacedim>::face_to_cell_index(
             break;
 
           default:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
         }
 
       return (this->get_first_line_index() +
@@ -1689,7 +1689,7 @@ FE_Q_Base<dim, spacedim>::has_support_on_face(
     }
 
   // we should not have gotten here
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return false;
 }
 
index d8b30081f6e56986abe23a3e72f62b6ba3aa4fca..290e8ea06c9b20311521167ea75a9782be2c70b3 100644 (file)
@@ -85,7 +85,7 @@ namespace internal
               q_fine = std::make_unique<QGauss<dim>>(degree + 1);
               break;
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
 
         Assert(q_fine.get() != nullptr, ExcInternalError());
index 0d4e61f5f7e00b58acf89e6372dcb17586494009..1485511420ec9824a0c0548a7cd2a2a53c7ab2f4 100644 (file)
@@ -2284,7 +2284,7 @@ FE_Q_Hierarchical<dim>::has_support_on_face(const unsigned int shape_index,
     }
 
   // we should not have gotten here
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return false;
 }
 
index daf7479aafed7f9628dba330fb9edc85a55d3a96..14f3e2164a06f601b95f4a69490b7ba5b03241cf 100644 (file)
@@ -1053,7 +1053,7 @@ FESystem<dim, spacedim>::face_to_cell_index(
     if (this->system_to_base_index(i) == target)
       return i;
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return numbers::invalid_unsigned_int;
 }
 
@@ -1557,7 +1557,7 @@ FESystem<dim, spacedim>::build_interface_constraints()
               {
                 // we should never get here!  (in 1d, the constraints matrix
                 // should be of size zero)
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
                 break;
               }
 
index 7f7087b8e52917f99fc1afef46361c47f10796f0..c51c16873f45766f0c5c584f0490edb0e62f863f 100644 (file)
@@ -945,7 +945,7 @@ FESubfaceValues<dim, spacedim>::do_reinit(const unsigned int face_no,
                   subface_index = cell->face(face_no)->child_index(1);
                   break;
                 default:
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
               }
             break;
           case internal::SubfaceCase<3>::case_x2y:
@@ -961,11 +961,11 @@ FESubfaceValues<dim, spacedim>::do_reinit(const unsigned int face_no,
                     cell->face(face_no)->child(1)->child_index(subface_no - 1);
                   break;
                 default:
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
               }
             break;
           default:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             break;
         }
       Assert(subface_index != numbers::invalid_unsigned_int,
index 67768b2926ec0898d2b6227faa9fff3a5cc6c428..0e13816f0b9c324d0f0562da09c686af5c5bd495 100644 (file)
@@ -632,7 +632,7 @@ namespace FEValuesViews
                             }
 
                           default:
-                            Assert(false, ExcInternalError());
+                            DEAL_II_ASSERT_UNREACHABLE();
                         }
                     }
 
index 75ecb3c1b27928bdc2f742c7ed32cc48aad480f0..835726559517a443457b29123cbfe828db1449b1 100644 (file)
@@ -134,7 +134,7 @@ FE_WedgePoly<dim, spacedim>::FE_WedgePoly(
       for (const auto &p : fe_quad.get_unit_support_points())
         this->unit_face_support_points[f].emplace_back(p[0], p[1]);
     else
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
index e7bc4f73530fb24402cb8275ce280310d0e9e398..cb9a8d96b92255bbe37dbc118dd32c38d006bfe7 100644 (file)
@@ -186,7 +186,7 @@ Mapping<dim, spacedim>::project_real_point_to_unit_point_on_face(
     }
 
   // We should never get here
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return {};
 }
 
index fd4ab49ce59c4d12e3e54dba2de4e0e6c20f2ce4..34f88f7903e63e5c6c37c64172acc30926f0c17f 100644 (file)
@@ -327,7 +327,7 @@ MappingQ<dim, spacedim>::transform_real_to_unit_cell_internal(
   const Point<dim> &) const
 {
   // default implementation (should never be called)
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return {};
 }
 
@@ -543,7 +543,7 @@ MappingQ<dim, spacedim>::transform_real_to_unit_cell(
               default:
                 {
                   // we should get here, based on the if-condition at the top
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
                 }
             }
         }
@@ -1625,7 +1625,7 @@ MappingQ<dim, spacedim>::add_quad_support_points(
   const typename Triangulation<dim, spacedim>::cell_iterator &,
   std::vector<Point<spacedim>> &) const
 {
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
index eb1b64431aea9eaedbc15b12f9f5583377b14e2a..dbda71490baaf2de5b91490ed4225f9796869773 100644 (file)
@@ -1324,7 +1324,7 @@ namespace GridGenerator
                 // is on the boundary,
                 // but we could not find
                 // on which boundary.
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
 
       for (const auto &cell : tria.cell_iterators())
@@ -1524,7 +1524,7 @@ namespace GridGenerator
                       cell->face(f)->line(j)->set_boundary_id(1);
               }
             else
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
     }
 
@@ -2315,7 +2315,7 @@ namespace GridGenerator
             break;
           }
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
       }
     (void)twisted_data; // make the static analyzer happy
     Assert(
@@ -5892,7 +5892,7 @@ namespace GridGenerator
               new_points[v][2] = -tria_copy.get_vertices()[v][2];
             }
         else
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
 
 
         // the cell data is exactly the same as before
@@ -7811,7 +7811,7 @@ namespace GridGenerator
             break;
           }
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
       }
 
     out_tria.create_triangulation(v, cells, subcelldata);
index 5540a823edee9621d3674615ab562f10c44fccae..d008699d9a1face4080614127a0d8f9a6f107020 100644 (file)
@@ -521,7 +521,7 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
                             cells[i].manifold_id =
                               static_cast<types::manifold_id>(id);
                           else
-                            Assert(false, ExcInternalError());
+                            DEAL_II_ASSERT_UNREACHABLE();
                         }
 
                       if (dim == 3)
@@ -537,7 +537,7 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
                                 boundary_quad.manifold_id =
                                   static_cast<types::manifold_id>(id);
                               else
-                                Assert(false, ExcInternalError());
+                                DEAL_II_ASSERT_UNREACHABLE();
                             }
                           for (auto &boundary_line : subcelldata.boundary_lines)
                             {
@@ -550,7 +550,7 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
                                 boundary_line.manifold_id =
                                   static_cast<types::manifold_id>(id);
                               else
-                                Assert(false, ExcInternalError());
+                                DEAL_II_ASSERT_UNREACHABLE();
                             }
                         }
                       else if (dim == 2)
@@ -566,7 +566,7 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
                                 boundary_line.manifold_id =
                                   static_cast<types::manifold_id>(id);
                               else
-                                Assert(false, ExcInternalError());
+                                DEAL_II_ASSERT_UNREACHABLE();
                             }
                         }
                     }
@@ -1766,7 +1766,7 @@ GridIn<dim, spacedim>::read_comsol_mphtxt(std::istream &in)
                   cells.back().vertices = vertices_for_this_element;
                 }
               else
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
             }
           else
             DEAL_II_NOT_IMPLEMENTED();
@@ -1825,7 +1825,7 @@ GridIn<dim, spacedim>::read_comsol_mphtxt(std::istream &in)
                     cells[cells.size() - n_elements + e].material_id =
                       geometric_entity_index;
                   else
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                 }
               else
                 DEAL_II_NOT_IMPLEMENTED();
@@ -4237,7 +4237,7 @@ GridIn<dim, spacedim>::read(std::istream &in, Format format)
       case Default:
         break;
     }
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
index 7de2bb91ae6c8d8989d69b637e3183156433ef6d..3f920a515f587e8e4f0bd2e92a98fe5a6ae67cc7 100644 (file)
@@ -1353,7 +1353,7 @@ GridOut::write_xfig(const Triangulation<2> &tria,
             out << cell->level_subdomain_id() + 32;
             break;
           default:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
         }
 
       // Depth, unused, fill
@@ -3923,7 +3923,7 @@ GridOut::write_msh_faces(const Triangulation<dim, spacedim> &tria,
                      (face->reference_cell() == ReferenceCells::Line))
               out << ' ' << face->vertex_index(vertex) + 1;
             else
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
           }
         out << '\n';
 
@@ -4711,7 +4711,7 @@ namespace internal
         {
           case 1:
             {
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
               break;
             }
 
@@ -5168,7 +5168,7 @@ GridOut::write(const Triangulation<dim, spacedim> &tria,
         return;
     }
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
index e9f675b212a2c9458b57049df0d38099d0dbc253..e8cfcb2cced6629dcb4651f1390b525ecb71611a 100644 (file)
@@ -3477,7 +3477,7 @@ namespace GridTools
           else
             {
               // We should not get here. Throw an error.
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
             }
         }
     // Now make sure we send out the rest of the points that we did not find.
index 3fc5b0d57f06e7610678fb6d1bf090a594772626..30aaf67ff1c9fb6928ffdeb1de0539a36af50c4d 100644 (file)
@@ -1445,7 +1445,7 @@ namespace GridTools
                         starting_vertex_of_edge[3]))
                 origin_vertex_of_cell = starting_vertex_of_edge[1];
               else
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
 
               break;
             }
index bde0e13fbbb6ed0e878bc0a484ccc237b73b273a..a97aa1aa77d87a3380e4ac3190e98d75efca2cb8 100644 (file)
@@ -2328,7 +2328,7 @@ TransfiniteInterpolationManifold<dim, spacedim>::compute_chart_points(
         case 0:
         case 1:
         case 2:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           break;
         case 3:
           return chart_points[1] + (chart_points[2] - chart_points[0]);
@@ -2341,7 +2341,7 @@ TransfiniteInterpolationManifold<dim, spacedim>::compute_chart_points(
         case 7:
           return 0.5 * (chart_points[2] + chart_points[3]);
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
       }
 
     return {};
@@ -2537,7 +2537,7 @@ TransfiniteInterpolationManifold<dim, spacedim>::compute_chart_points(
   // a valid inversion should have returned a point above. an invalid
   // inversion should have triggered the assertion, so we should never end up
   // here
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
   return typename Triangulation<dim, spacedim>::cell_iterator();
 }
 
index 81bd8818cd5d81d0cf3395e3748c232201aaa83f..12981288dd639590ae27bf792f0e00592a859572 100644 (file)
@@ -152,7 +152,7 @@ PersistentTriangulation<dim, spacedim>::create_triangulation(
 {
   (void)construction_data;
 
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
index 9e0e9c570acaf22f62bca02d4cf83948f1ad7b80..6e9f9f6aa33e63d7f87cce7d2cbe5014acea69df 100644 (file)
@@ -845,7 +845,7 @@ namespace
                   const Point<dim> & /*p*/,
                   const ReferenceCell /*reference_cell*/)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
     return std::make_pair(Point<dim>(),
                           std::numeric_limits<double>::signaling_NaN());
   }
@@ -1067,7 +1067,7 @@ ReferenceCell::closest_point(const Point<dim> &p) const
       switch (this->kind)
         {
           case ReferenceCells::Vertex:
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             break;
             // the bounds for each dimension of a hypercube are mutually
             // independent:
index 7ce15adee8a39ea0d4d67d6b7dc7313b9cdd6832..ce80da5ec12e5ba877d9aa70164382d30333b86a 100644 (file)
@@ -224,7 +224,7 @@ namespace internal
                 break;
 
               default:
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
                 break;
             }
 
@@ -655,7 +655,7 @@ namespace internal
               break;
 
             default:
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
               break;
           }
 
@@ -4077,7 +4077,7 @@ namespace internal
             default:
               // only remaining case is
               // no_refinement, thus an error
-              Assert(false, ExcInternalError());
+              DEAL_II_ASSERT_UNREACHABLE();
               break;
           }
 
@@ -4479,7 +4479,7 @@ namespace internal
                   break;
 
                 default:
-                  Assert(false, ExcInternalError());
+                  DEAL_II_ASSERT_UNREACHABLE();
                   break;
               }
           }
@@ -6085,7 +6085,7 @@ namespace internal
                     }
                   else
                     {
-                      Assert(false, ExcInternalError());
+                      DEAL_II_ASSERT_UNREACHABLE();
                     }
 
                   // Also check whether we have to refine any of the faces and
@@ -6146,7 +6146,7 @@ namespace internal
               }
             else
               {
-                Assert(false, ExcInternalError());
+                DEAL_II_ASSERT_UNREACHABLE();
               }
           }
 
@@ -7331,7 +7331,7 @@ namespace internal
                   else
                     {
                       // we should never get here
-                      Assert(false, ExcInternalError());
+                      DEAL_II_ASSERT_UNREACHABLE();
                     }
 
                   // mark all faces for refinement; checking locally
@@ -8582,7 +8582,7 @@ namespace internal
                         n_new_hexes = 8;
                         break;
                       default:
-                        Assert(false, ExcInternalError());
+                        DEAL_II_ASSERT_UNREACHABLE();
                         break;
                     }
 
@@ -11476,7 +11476,7 @@ namespace internal
                         // untreated enumeration value. However, in that
                         // case we should have aborted much
                         // earlier. thus we should never get here
-                        Assert(false, ExcInternalError());
+                        DEAL_II_ASSERT_UNREACHABLE();
                         break;
                     } // switch (ref_case)
 
@@ -13522,7 +13522,7 @@ namespace
   bool
   get_user_flag(const TriaIterator<InvalidAccessor<structdim, dim, spacedim>> &)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
     return false;
   }
 
@@ -13541,7 +13541,7 @@ namespace
   void
   set_user_flag(const TriaIterator<InvalidAccessor<structdim, dim, spacedim>> &)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
   }
 
 
@@ -13560,7 +13560,7 @@ namespace
   clear_user_flag(
     const TriaIterator<InvalidAccessor<structdim, dim, spacedim>> &)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
   }
 } // namespace
 
@@ -13813,7 +13813,7 @@ namespace
   get_user_index(
     const TriaIterator<InvalidAccessor<structdim, dim, spacedim>> &)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
     return numbers::invalid_unsigned_int;
   }
 
@@ -13834,7 +13834,7 @@ namespace
     const TriaIterator<InvalidAccessor<structdim, dim, spacedim>> &,
     const unsigned int)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
   }
 } // namespace
 
@@ -13959,7 +13959,7 @@ namespace
   get_user_pointer(
     const TriaIterator<InvalidAccessor<structdim, dim, spacedim>> &)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
     return nullptr;
   }
 
@@ -13980,7 +13980,7 @@ namespace
     const TriaIterator<InvalidAccessor<structdim, dim, spacedim>> &,
     void *)
   {
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
   }
 } // namespace
 
index fc197f6877ee144f90077d9fe2806a904a77f2ee..0d9a30a9237c888820f9fc0bbc8f74c84f82ba87 100644 (file)
@@ -224,7 +224,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
         return {};
       }
   }
@@ -1265,7 +1265,7 @@ namespace
         Assert(accessor.reference_cell() != ReferenceCells::Pyramid &&
                  accessor.reference_cell() != ReferenceCells::Wedge,
                ExcNotImplemented());
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
 
         return {};
       }
@@ -2582,7 +2582,7 @@ CellAccessor<dim, spacedim>::neighbor_of_coarser_neighbor(
           // we should never get here,
           // since then we did not find
           // our way back...
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           return std::make_pair(numbers::invalid_unsigned_int,
                                 numbers::invalid_unsigned_int);
         }
@@ -2675,7 +2675,7 @@ CellAccessor<dim, spacedim>::neighbor_of_coarser_neighbor(
 
           // we should never get here, since then we did not find our way
           // back...
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           return std::make_pair(numbers::invalid_unsigned_int,
                                 numbers::invalid_unsigned_int);
         }
@@ -3429,7 +3429,7 @@ CellAccessor<dim, spacedim>::neighbor_child_on_subface(
                           requested = mother_face->child(1);
                           break;
                         default:
-                          Assert(false, ExcInternalError());
+                          DEAL_II_ASSERT_UNREACHABLE();
                       }
                     break;
                   case internal::SubfaceCase<3>::case_x2y:
@@ -3444,11 +3444,11 @@ CellAccessor<dim, spacedim>::neighbor_child_on_subface(
                           requested = mother_face->child(1)->child(subface - 1);
                           break;
                         default:
-                          Assert(false, ExcInternalError());
+                          DEAL_II_ASSERT_UNREACHABLE();
                       }
                     break;
                   default:
-                    Assert(false, ExcInternalError());
+                    DEAL_II_ASSERT_UNREACHABLE();
                     break;
                 }
               Assert(requested == neighbor_child->face(neighbor_neighbor),
index fa3cec1e8d8ac9d9809ecbc576a9e166f2704669..2a3754e906164dddcf936fb86872c2962004fb06 100644 (file)
@@ -326,7 +326,7 @@ namespace hp
             &dof_handler.get_triangulation()) == nullptr)
         {
 #ifndef DEAL_II_WITH_P4EST
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
 #else
           //
           // parallel implementation with distributed memory
@@ -776,7 +776,7 @@ namespace hp
                           {
                             // Siblings of locally owned cells are all
                             // either also locally owned or ghost cells.
-                            Assert(false, ExcInternalError());
+                            DEAL_II_ASSERT_UNREACHABLE();
                           }
                       }
                   }
index 3430a81256f5030f3a859621d54bb987ac6a88ed..2211757fcdbc7c117f097b480c00e23bae37f8a8 100644 (file)
@@ -2664,7 +2664,7 @@ ScaLAPACKMatrix<NumberType>::save_serial(
 #  ifndef DEAL_II_WITH_HDF5
   (void)filename;
   (void)chunk_size;
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 #  else
 
   /*
@@ -2821,7 +2821,7 @@ ScaLAPACKMatrix<NumberType>::save_parallel(
 #  ifndef DEAL_II_WITH_HDF5
   (void)filename;
   (void)chunk_size;
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 #  else
 
   const unsigned int n_mpi_processes(
@@ -3075,7 +3075,7 @@ ScaLAPACKMatrix<NumberType>::load_serial(const std::string &filename)
 {
 #  ifndef DEAL_II_WITH_HDF5
   (void)filename;
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 #  else
 
   /*
@@ -3253,10 +3253,10 @@ ScaLAPACKMatrix<NumberType>::load_parallel(const std::string &filename)
 {
 #  ifndef DEAL_II_WITH_HDF5
   (void)filename;
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 #  else
 #    ifndef H5_HAVE_PARALLEL
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 #    else
 
   const unsigned int n_mpi_processes(
index c7045b36e9d37187e3cada4345f4c27940a40481..e8385a68fe862fb54593c67b2196888cafeb5d35 100644 (file)
@@ -225,7 +225,7 @@ namespace NonMatching
           }
         default:
           {
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             break;
           }
       }
@@ -445,7 +445,7 @@ namespace NonMatching
           }
         default:
           {
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
             break;
           }
       }
index cce2a6e2d10926721bd01c42b9f68450f0cadd78..5332ab98f7b9bf3bb410de868dc396442d4b543c 100644 (file)
@@ -236,7 +236,7 @@ DataOutStack<dim, spacedim>::add_data_vector(
   // we have either return or Assert
   // statements above, so shouldn't
   // get here!
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
index aade357751bd1638168d677093c9883f4da5d2d0..9057b5ea45d323269524ffc8ee83a2e941e9545f 100644 (file)
@@ -126,7 +126,7 @@ Histogram::evaluate(const std::vector<Vector<number>> &values,
         }
 
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
   // move right bound arbitrarily if
@@ -175,7 +175,7 @@ Histogram::evaluate(const std::vector<Vector<number>> &values,
         }
 
       default:
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     }
 
   // fill the other lists of intervals
index 51f8435bba0629f2af1ebaa174b26afcc8288013..ae5463576844ab8bfabbe2c9931cea74ea37f672 100644 (file)
@@ -579,7 +579,7 @@ SolutionTransfer<dim, VectorType, spacedim>::interpolate(
             }
           // undefined status
           else
-            Assert(false, ExcInternalError());
+            DEAL_II_ASSERT_UNREACHABLE();
         }
     }
 
index ce770df6635f5feb0482e92bfb70febbc8379bbc..ea9541a2d6522841cae702788a474d484b114d56 100644 (file)
@@ -706,7 +706,7 @@ namespace
         return changed_grid;
       }
 
-    Assert(false, ExcInternalError());
+    DEAL_II_ASSERT_UNREACHABLE();
     return false;
   }
 
@@ -1164,7 +1164,7 @@ TimeStepBase_Tria_Flags::Flags<dim>::Flags()
   , wakeup_level_to_build_grid(0)
   , sleep_level_to_delete_grid(0)
 {
-  Assert(false, ExcInternalError());
+  DEAL_II_ASSERT_UNREACHABLE();
 }
 
 
index 8ed7226bc80362efe9e458f60aa12d3dfaa6888a..38374c8cef5d8a0e7e9064523fb3e5aacdf7652a 100644 (file)
@@ -64,7 +64,7 @@ namespace OpenCASCADE
         return Handle(BRepAdaptor_Curve)(
           new BRepAdaptor_Curve(TopoDS::Edge(shape)));
 
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
       return Handle(BRepAdaptor_Curve)(new BRepAdaptor_Curve());
     }
 #  else
@@ -81,7 +81,7 @@ namespace OpenCASCADE
         return Handle(BRepAdaptor_HCurve)(
           new BRepAdaptor_HCurve(TopoDS::Edge(shape)));
 
-      Assert(false, ExcInternalError());
+      DEAL_II_ASSERT_UNREACHABLE();
       return Handle(BRepAdaptor_HCurve)(new BRepAdaptor_HCurve());
     }
 #  endif
index f0e21a920f14b4c792885b3c3e0d7eb932f581b4..df6d147959ebdfc322d2ecbcd04c6f9e4154877d 100644 (file)
@@ -2336,7 +2336,7 @@ namespace Particles
           break;
 
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           break;
       }
 
@@ -2485,7 +2485,7 @@ namespace Particles
           break;
 
         default:
-          Assert(false, ExcInternalError());
+          DEAL_II_ASSERT_UNREACHABLE();
           break;
       }
   }
index b82eaac1e0c8b288cd98a301ef863f5ccf092415..4e2541078b5af4ad86e08306dd736430539201b6 100644 (file)
@@ -101,7 +101,7 @@ namespace SUNDIALS
       else if (value == "picard")
         strategy = picard;
       else
-        Assert(false, ExcInternalError());
+        DEAL_II_ASSERT_UNREACHABLE();
     });
     prm.add_parameter("Maximum number of nonlinear iterations",
                       maximum_non_linear_iterations);
@@ -149,7 +149,7 @@ namespace SUNDIALS
                        anderson_qr_orthogonalization =
                          delayed_classical_gram_schmidt;
                      else
-                       Assert(false, ExcInternalError());
+                       DEAL_II_ASSERT_UNREACHABLE();
                    });
     prm.leave_subsection();
   }

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.