]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use DEAL_II_NOT_IMPLEMENTED().
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 25 Jan 2024 21:15:00 +0000 (14:15 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Fri, 26 Jan 2024 17:18:44 +0000 (10:18 -0700)
261 files changed:
include/deal.II/base/function_parser.h
include/deal.II/base/geometry_info.h
include/deal.II/base/polynomial_space.h
include/deal.II/base/polynomials_adini.h
include/deal.II/base/polynomials_rannacher_turek.h
include/deal.II/base/scalar_polynomials_base.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/table.h
include/deal.II/base/tensor_function_parser.h
include/deal.II/base/tensor_product_polynomials.h
include/deal.II/base/tensor_product_polynomials_bubbles.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/fe/fe_dg_vector.templates.h
include/deal.II/fe/fe_face.h
include/deal.II/fe/fe_poly.templates.h
include/deal.II/fe/fe_poly_face.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/fe/fe_tools_interpolate.templates.h
include/deal.II/fe/fe_values_views.h
include/deal.II/fe/mapping_q_internal.h
include/deal.II/grid/connectivity.h
include/deal.II/grid/grid_tools_geometry.h
include/deal.II/grid/reference_cell.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/hp/q_collection.h
include/deal.II/integrators/maxwell.h
include/deal.II/lac/affine_constraints.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/blas_extension_templates.h
include/deal.II/lac/chunk_sparse_matrix.templates.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/householder.h
include/deal.II/lac/lapack_support.h
include/deal.II/lac/lapack_templates.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.templates.h
include/deal.II/lac/precondition_block_base.h
include/deal.II/lac/precondition_selector.h
include/deal.II/lac/relaxation_block.templates.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/lac/trilinos_tpetra_vector.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_evaluation.h
include/deal.II/matrix_free/fe_remote_evaluation.h
include/deal.II/matrix_free/hanging_nodes_internal.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/matrix_free/vector_access_internal.h
include/deal.II/meshworker/vector_selector.templates.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
include/deal.II/multigrid/multigrid.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/matrix_creator.templates.h
include/deal.II/numerics/vector_tools_boundary.templates.h
include/deal.II/numerics/vector_tools_constraints.templates.h
include/deal.II/numerics/vector_tools_evaluate.h
include/deal.II/numerics/vector_tools_integrate_difference.templates.h
include/deal.II/trilinos/nox.templates.h
source/base/auto_derivative_function.cc
source/base/data_out_base.cc
source/base/exceptions.cc
source/base/flow_function.cc
source/base/function_derivative.cc
source/base/function_lib.cc
source/base/function_signed_distance.cc
source/base/function_spherical.cc
source/base/geometric_utilities.cc
source/base/parameter_handler.cc
source/base/patterns.cc
source/base/polynomials_abf.cc
source/base/polynomials_barycentric.cc
source/base/polynomials_bdm.cc
source/base/polynomials_bernardi_raugel.cc
source/base/polynomials_nedelec.cc
source/base/polynomials_pyramid.cc
source/base/polynomials_rannacher_turek.cc
source/base/polynomials_rt_bubbles.cc
source/base/polynomials_wedge.cc
source/base/quadrature.cc
source/base/quadrature_lib.cc
source/base/scalar_polynomials_base.cc
source/base/tensor_product_polynomials.cc
source/base/tensor_product_polynomials_bubbles.cc
source/base/tensor_product_polynomials_const.cc
source/base/timer.cc
source/base/utilities.cc
source/cgal/intersections.cc
source/distributed/fully_distributed_tria.cc
source/distributed/grid_refinement.cc
source/distributed/p4est_wrappers.cc
source/distributed/shared_tria.cc
source/distributed/tria.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler_policy.cc
source/dofs/dof_renumbering.cc
source/fe/fe.cc
source/fe/fe_abf.cc
source/fe/fe_bernstein.cc
source/fe/fe_dgp.cc
source/fe/fe_dgp_monomial.cc
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgq.cc
source/fe/fe_enriched.cc
source/fe/fe_face.cc
source/fe/fe_hermite.cc
source/fe/fe_nedelec.cc
source/fe/fe_nedelec_sz.cc
source/fe/fe_poly_tensor.cc
source/fe/fe_pyramid_p.cc
source/fe/fe_q.cc
source/fe/fe_q_base.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_dg0.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_q_iso_q1.cc
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_rt_bubbles.cc
source/fe/fe_simplex_p.cc
source/fe/fe_simplex_p_bubbles.cc
source/fe/fe_system.cc
source/fe/fe_trace.cc
source/fe/fe_values_views_internal.cc
source/fe/fe_wedge_p.cc
source/fe/mapping_c1.cc
source/fe/mapping_cartesian.cc
source/fe/mapping_fe.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_manifold.cc
source/fe/mapping_q.cc
source/grid/grid_generator.cc
source/grid/grid_generator_pipe_junction.cc
source/grid/grid_in.cc
source/grid/grid_out.cc
source/grid/grid_refinement.cc
source/grid/grid_tools.cc
source/grid/grid_tools_topology.cc
source/grid/manifold.cc
source/grid/manifold_lib.cc
source/grid/reference_cell.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/lac/cuda_precondition.cc
source/lac/petsc_precondition.cc
source/lac/petsc_solver.cc
source/lac/slepc_solver.cc
source/lac/trilinos_solver.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_sparsity_pattern.cc
source/lac/trilinos_tpetra_sparsity_pattern.cc
source/matrix_free/fe_point_evaluation.cc
source/matrix_free/vector_data_exchange.cc
source/multigrid/mg_tools.cc
source/numerics/data_out.cc
source/numerics/data_out_rotation.cc
source/numerics/data_out_stack.cc
source/numerics/derivative_approximation.cc
source/opencascade/manifold_lib.cc
source/particles/data_out.cc
tests/base/quadrature_check_tensor_product.cc
tests/bits/distorted_cells_01.cc
tests/bits/distorted_cells_07.cc
tests/bits/static_condensation.cc
tests/bits/step-51.cc
tests/bits/step-51p.cc
tests/bits/step-7.cc
tests/bits/step-8.cc
tests/codim_one/bem.cc
tests/data_out/data_out_postprocessor_01-new.cc
tests/data_out/data_out_postprocessor_scalar_01-new.cc
tests/data_out/data_out_postprocessor_vector_01-new.cc
tests/data_out/data_out_postprocessor_vector_complex_01.cc
tests/distributed_grids/3d_coarse_grid_05.cc
tests/dofs/nodal_renumbering_01.cc
tests/epetraext/trilinos_sparse_matrix_mmult_01.cc
tests/fe/bdm_2.cc
tests/fe/fe_enriched_step-36.cc
tests/fe/fe_enriched_step-36b.cc
tests/fe/fe_tools_test.cc
tests/fe/fe_values_function_manifold.cc
tests/fe/nedelec.cc
tests/fe/numbering.cc
tests/fe/rt_2.cc
tests/fe/rt_bubbles_2.cc
tests/fe/up_and_down.cc
tests/grid/enclosing_sphere_01.cc
tests/grid/extent_in_direction.cc
tests/grid/get_dof_to_support_patch_map_01.cc
tests/grid/measure_et_al.cc
tests/grid/measure_et_al_02.cc
tests/grid/merge_triangulations_01.cc
tests/grid/normal_vector_01.cc
tests/grid/normal_vector_01_2d.cc
tests/grid/normal_vector_03.cc
tests/grid/normal_vector_03_2d.cc
tests/grid/normals_at_vertices_01.cc
tests/hp/crash_17.cc
tests/hp/crash_18.cc
tests/hp/flux_sparsity.cc
tests/hp/flux_sparsity_02.cc
tests/hp/hp_constraints_common.h
tests/hp/hp_constraints_common_no_support.h
tests/hp/interpolate_nothing_02.cc
tests/hp/step-7.cc
tests/hp/step-8.cc
tests/lac/inhomogeneous_constraints.cc
tests/lac/sparse_ilu.cc
tests/lac/sparse_ilu_t.cc
tests/lac/sparse_mic.cc
tests/mappings/mapping.cc
tests/matrix_free/ecl.h
tests/matrix_free/ecl_fe_q.h
tests/matrix_free/mixed_mesh_hn_algorithm_01.cc
tests/matrix_free/poisson_dg_hp.cc
tests/matrix_free/stokes_computation.cc
tests/matrix_free_kokkos/matrix_vector_device_mf.h
tests/mpi/trilinos_matvec_01.cc
tests/mpi/trilinos_matvec_02.cc
tests/mpi/trilinos_matvec_03.cc
tests/mpi/trilinos_sparse_matrix_01.cc
tests/mpi/trilinos_sparse_matrix_02.cc
tests/mpi/trilinos_sparse_matrix_03.cc
tests/mpi/trilinos_sparse_matrix_04.cc
tests/mpi/trilinos_sparse_matrix_05.cc
tests/mpi/trilinos_sparse_matrix_print_01.cc
tests/multigrid-global-coarsening/multigrid_util.h
tests/multigrid-global-coarsening/stokes_computation.cc
tests/numerics/no_flux_04.cc
tests/numerics/no_flux_18.cc
tests/numerics/no_flux_hp_04.cc
tests/numerics/project_common.h
tests/numerics/project_parallel_common.h
tests/numerics/smoothness_estimator_02.cc
tests/performance/timing_navier_stokes.cc
tests/petsc/70.cc
tests/petsc/step-67-with-petsc-ts.cc
tests/physics/step-18-rotation_matrix.cc
tests/physics/step-18.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_04.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_06.cc
tests/simplex/cell_measure_01.cc
tests/simplex/data_out_write_vtk_02.cc
tests/simplex/matrix_free_01.cc
tests/simplex/matrix_free_04.cc
tests/simplex/matrix_free_face_integral_01.cc
tests/simplex/step-07.cc
tests/simplex/step-08.cc
tests/simplex/step-67.cc
tests/simplex/step-74.cc
tests/slepc/solve_04.cc
tests/tensors/project_orthogonal.cc
tests/tensors/symmetric_tensor_19.cc
tests/trilinos/70.cc
tests/umfpack/umfpack_04.cc
tests/vector_tools/integrate_difference_05.cc

index 8067fd2a7681d3a5a9cdb5c373a720ab219f7f6f..ded4a556e7986c42ea80c1cd2beacd371f589e66 100644 (file)
@@ -385,7 +385,7 @@ FunctionParser<dim>::default_variable_names()
       case 3:
         return "x,y,z";
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return "";
 }
index d40be658fd96e86ca704492232544817ec88e2c9..daf0d42c6183fada955c2b634684e63e0d1b38ec 100644 (file)
@@ -3001,7 +3001,7 @@ template <int dim>
 inline Point<dim>
 GeometryInfo<dim>::unit_cell_vertex(const unsigned int)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return {};
 }
@@ -3049,7 +3049,7 @@ template <int dim>
 inline unsigned int
 GeometryInfo<dim>::child_cell_from_point(const Point<dim> &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return 0;
 }
@@ -3188,7 +3188,7 @@ GeometryInfo<dim>::cell_to_child_coordinates(
   const RefinementCase<dim> /*refine_case*/)
 
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -3324,7 +3324,7 @@ GeometryInfo<dim>::child_to_cell_coordinates(
   const unsigned int /*child_index*/,
   const RefinementCase<dim> /*refine_case*/)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -3334,7 +3334,7 @@ template <int dim>
 inline bool
 GeometryInfo<dim>::is_inside_unit_cell(const Point<dim> &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return false;
 }
 
@@ -3370,7 +3370,7 @@ template <int dim>
 inline bool
 GeometryInfo<dim>::is_inside_unit_cell(const Point<dim> &, const double)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return false;
 }
 
@@ -3457,7 +3457,7 @@ template <>
 inline unsigned int
 GeometryInfo<4>::line_to_cell_vertices(const unsigned int, const unsigned int)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return numbers::invalid_unsigned_int;
 }
 
@@ -3543,7 +3543,7 @@ template <int dim>
 inline unsigned int
 GeometryInfo<dim>::n_subfaces(const internal::SubfaceCase<dim> &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
@@ -3580,7 +3580,7 @@ inline double
 GeometryInfo<dim>::subface_ratio(const internal::SubfaceCase<dim> &,
                                  const unsigned int)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0.;
 }
 
@@ -3699,7 +3699,7 @@ RefinementCase<dim - 1> inline GeometryInfo<dim>::face_refinement_case(
   const bool,
   const bool)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return RefinementCase<dim - 1>::no_refinement;
 }
 
@@ -3837,7 +3837,7 @@ inline RefinementCase<1>
 GeometryInfo<dim>::line_refinement_case(const RefinementCase<dim> &,
                                         const unsigned int)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return RefinementCase<1>::no_refinement;
 }
 
@@ -3915,7 +3915,7 @@ GeometryInfo<dim>::min_cell_refinement_case_for_face_refinement(
   const bool,
   const bool)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return RefinementCase<dim>::no_refinement;
 }
@@ -4021,7 +4021,7 @@ inline RefinementCase<dim>
 GeometryInfo<dim>::min_cell_refinement_case_for_line_refinement(
   const unsigned int)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return RefinementCase<dim>::no_refinement;
 }
@@ -4202,7 +4202,7 @@ GeometryInfo<dim>::standard_to_real_face_line(const unsigned int line,
                                               const bool,
                                               const bool)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return line;
 }
 
@@ -4223,7 +4223,7 @@ inline unsigned int
 GeometryInfo<dim>::standard_to_real_line_vertex(const unsigned int vertex,
                                                 const bool)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return vertex;
 }
 
@@ -4244,7 +4244,7 @@ inline std::array<unsigned int, 2>
 GeometryInfo<dim>::standard_quad_vertex_to_line_vertex_index(
   const unsigned int vertex)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   (void)vertex;
   return {{0, 0}};
 }
@@ -4285,7 +4285,7 @@ template <int dim>
 inline std::array<unsigned int, 2>
 GeometryInfo<dim>::standard_hex_line_to_quad_line_index(const unsigned int line)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   (void)line;
   return {{0, 0}};
 }
@@ -4312,7 +4312,7 @@ inline std::array<unsigned int, 2>
 GeometryInfo<dim>::standard_hex_vertex_to_quad_vertex_index(
   const unsigned int vertex)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   (void)vertex;
   return {{0, 0}};
 }
@@ -4380,7 +4380,7 @@ GeometryInfo<dim>::real_to_standard_face_line(const unsigned int line,
                                               const bool,
                                               const bool)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return line;
 }
 
@@ -4678,7 +4678,7 @@ GeometryInfo<4>::child_cell_on_face(const RefinementCase<4> &,
                                     const bool,
                                     const RefinementCase<3> &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return numbers::invalid_unsigned_int;
 }
 
@@ -4733,7 +4733,7 @@ GeometryInfo<0>::face_to_cell_lines(const unsigned int,
                                     const bool,
                                     const bool)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return numbers::invalid_unsigned_int;
 }
 
@@ -4747,7 +4747,7 @@ GeometryInfo<dim>::face_to_cell_lines(const unsigned int,
                                       const bool,
                                       const bool)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return numbers::invalid_unsigned_int;
 }
 
@@ -4778,7 +4778,7 @@ GeometryInfo<0>::face_to_cell_vertices(const unsigned int,
                                        const bool,
                                        const bool)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return numbers::invalid_unsigned_int;
 }
 
@@ -4883,7 +4883,7 @@ GeometryInfo<dim>::d_linear_shape_function(const Point<dim>  &xi,
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return -1e9;
 }
@@ -4977,7 +4977,7 @@ inline Tensor<1, dim>
 GeometryInfo<dim>::d_linear_shape_function_gradient(const Point<dim> &,
                                                     const unsigned int)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return Tensor<1, dim>();
 }
 
index 20fa41c7b16e9e394597774c4fdc64378c210984..fc2b4739257cb1f0b318bebad57bbdc9b5c52d9b 100644 (file)
@@ -445,7 +445,7 @@ PolynomialSpace<dim>::compute_derivative(const unsigned int i,
         }
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return derivative;
         }
     }
index afa2c9f8f49f5102a0c4f2682ad32074aa9504b4..22aa9af823044c948a4616093d70dced04991dea 100644 (file)
@@ -181,7 +181,7 @@ inline Tensor<1, dim>
 PolynomialsAdini<dim>::compute_1st_derivative(const unsigned int /*i*/,
                                               const Point<dim> & /*p*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -192,7 +192,7 @@ inline Tensor<2, dim>
 PolynomialsAdini<dim>::compute_2nd_derivative(const unsigned int /*i*/,
                                               const Point<dim> & /*p*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -203,7 +203,7 @@ inline Tensor<3, dim>
 PolynomialsAdini<dim>::compute_3rd_derivative(const unsigned int /*i*/,
                                               const Point<dim> & /*p*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -214,7 +214,7 @@ inline Tensor<4, dim>
 PolynomialsAdini<dim>::compute_4th_derivative(const unsigned int /*i*/,
                                               const Point<dim> & /*p*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
index e6e47cf75045d58824561187240bfba88fd1aea6..361a804b9fa3f7af15547d514fd5ba42967f14a6 100644 (file)
@@ -183,7 +183,7 @@ namespace internal
                 }
               else
                 {
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
                 }
               return derivative;
             }
index 4ab3f99dd67056c034b1c47a04b5e73337e1443f..0b52a07cacf8d13aeadee48e6cd18da98ba0c4b6 100644 (file)
@@ -279,7 +279,7 @@ ScalarPolynomialsBase<dim>::compute_derivative(const unsigned int i,
       auto derivative = compute_4th_derivative(i, p);
       return *reinterpret_cast<Tensor<order, dim> *>(&derivative);
     }
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   Tensor<order, dim> empty;
   return empty;
 }
index e77ca5e888e15929750fca6d8f7c98302f87ef2e..3ba5c9abd87971b04f7ade3c66643959349cb382 100644 (file)
@@ -2084,7 +2084,7 @@ namespace internal
     component_to_unrolled_index(const TableIndices<rank_> &indices)
     {
       (void)indices;
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return numbers::invalid_unsigned_int;
     }
   } // namespace SymmetricTensorImplementation
@@ -2150,7 +2150,7 @@ namespace internal
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // The code should never reach here.
@@ -2198,7 +2198,7 @@ namespace internal
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // The code should never reach here.
@@ -2569,7 +2569,7 @@ namespace internal
                       0,
                       dealii::SymmetricTensor<rank_, dim, double>::
                         n_independent_components));
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return TableIndices<rank_>();
     }
 
@@ -2742,7 +2742,7 @@ determinant(const SymmetricTensor<2, dim, Number> &t)
                   t.data[2] * t.data[3] * t.data[3]);
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return internal::NumberType<Number>::value(0.0);
     }
 }
index e561cacf9d51eb51e03745d2f736006b5edcc804..5c894431895e8cb09328c8853c8a8b0aaeaeb7ce 100644 (file)
@@ -2533,7 +2533,7 @@ namespace internal
     void
     fill_Fortran_style(InputIterator, TableBase<N, T> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
   } // namespace TableImplementation
 } // namespace internal
index 1e44f2e5d72620dc70949f66f5b7ed9a585fc2bb..7c935e5b07ccfb7106046ac547e5e33c92da009d 100644 (file)
@@ -282,7 +282,7 @@ TensorFunctionParser<rank, dim, Number>::default_variable_names()
       case 3:
         return "x,y,z";
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return "";
 }
index 268ceedd440431d31858476a5d629dcc44ca8703..760700bf149be799ecfcb35fdcf57e549d5b3b7d 100644 (file)
@@ -663,7 +663,7 @@ TensorProductPolynomials<dim, PolynomialType>::compute_derivative(
         }
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return derivative;
         }
     }
@@ -840,7 +840,7 @@ AnisotropicPolynomials<dim>::compute_derivative(const unsigned int i,
         }
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return derivative;
         }
     }
index 17f27282339d242dbe0b63d53f077f8006c02f1f..6c62ba7e5dd6d57b10bcff60f1f00f288561f030 100644 (file)
@@ -454,7 +454,7 @@ TensorProductPolynomialsBubbles<dim>::compute_derivative(
         }
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return derivative;
         }
     }
index ff3170f960ec5683500eef73d1cfdbfa0160798c..51a7868d30876eaca193524de976d684f2826abc 100644 (file)
@@ -1876,7 +1876,7 @@ DoFAccessor<0, 1, spacedim, level_dof_access>::set_dof_index(
   const types::global_dof_index /*index*/,
   const types::fe_index /*fe_index*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2002,7 +2002,7 @@ inline bool
 DoFAccessor<0, 1, spacedim, level_dof_access>::fe_index_is_active(
   const types::fe_index /*fe_index*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return false;
 }
 
@@ -2058,7 +2058,7 @@ inline typename dealii::internal::DoFHandlerImplementation::
   DoFAccessor<0, 1, spacedim, level_dof_access>::line(
     const unsigned int /*c*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return typename dealii::internal::DoFHandlerImplementation::
     Iterators<1, spacedim, level_dof_access>::line_iterator();
 }
@@ -2071,7 +2071,7 @@ inline typename dealii::internal::DoFHandlerImplementation::
   DoFAccessor<0, 1, spacedim, level_dof_access>::quad(
     const unsigned int /*c*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return typename dealii::internal::DoFHandlerImplementation::
     Iterators<1, spacedim, level_dof_access>::quad_iterator();
 }
index ac179c29659195eed701ea3511b9f471e5d274b5..1b1a2c128ae96c1afd31ac09358d33d2e1582c3b 100644 (file)
@@ -102,7 +102,7 @@ template <typename PolynomialType, int dim, int spacedim>
 std::size_t
 FE_DGVector<PolynomialType, dim, spacedim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index 3e1cd84690a16f8994f307ca149ad913b30cfe2b..66af223173d962b12ff0020557732e4b09eff193 100644 (file)
@@ -375,7 +375,7 @@ protected:
     if (data_ptr->update_each & update_gradients ||
         data_ptr->update_each & update_hessians)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
     return data_ptr;
index 8a15f5a797e0460e42916b2b23782399e99c666d..b459d4f83e5f9b3a56179425066d4af2c40226dc 100644 (file)
@@ -600,7 +600,7 @@ FE_Poly<dim, spacedim>::get_poly_space_numbering() const
   if (space_tensor_prod_const != nullptr)
     return space_tensor_prod_const->get_numbering();
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return std::vector<unsigned int>();
 }
 
index 0bb9c20c1092e174395153a6c2f51ad496496984..f0010d547a3421f972e11c9c118cbe9833a98930 100644 (file)
@@ -161,7 +161,7 @@ protected:
     if (data.update_each & update_gradients ||
         data.update_each & update_hessians)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
     return data_ptr;
index feb89dedf32fc7a95b1c3a1ade2aa015392ca88c..45ce2aca81d3e5b11a65000bb807a63ae328d773 100644 (file)
@@ -1061,7 +1061,7 @@ namespace FETools
   std::unique_ptr<FiniteElement<FE::dimension, FE::space_dimension>>
   FEFactory<FE>::get(const Quadrature<1> &) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return nullptr;
   }
 
@@ -3204,7 +3204,7 @@ namespace FETools
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     return h2l;
index fa1faae8d01c0b07e56f42ad7acc4a014dd037eb..585ca57de1c90e91d3186ef800a7812b2e3dc26a 100644 (file)
@@ -57,7 +57,7 @@ namespace FETools
     public:
       ExtrapolateImplementation()
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       };
 
       template <class InVector>
@@ -66,7 +66,7 @@ namespace FETools
                            const DoFHandler<dim, spacedim> & /*dof2*/,
                            OutVector & /*u2*/)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
     };
 
@@ -1571,7 +1571,7 @@ namespace FETools
     void
     reinit_ghosted(const DH & /*dh*/, VectorType & /*vector*/)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 #ifdef DEAL_II_WITH_PETSC
index bea408341d888c6d5fb1ee17065a86dc9f3c6739..db8defde824c128a0ad0077087889678584d7751 100644 (file)
@@ -407,7 +407,7 @@ namespace FETools
       const AffineConstraints<PETScWrappers::MPI::BlockVector::value_type> &,
       PETScWrappers::MPI::BlockVector &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 #endif
 
index 50c4c6e716d367d6ab1b29a59a4563c0ce4562e6..868ad4b99a9d29a6d16449cc9464416d356fdb2d 100644 (file)
@@ -2763,7 +2763,7 @@ namespace FEValuesViews
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         divergence_type return_value;
         return return_value;
       }
@@ -2869,7 +2869,7 @@ namespace FEValuesViews
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         divergence_type return_value;
         return return_value;
       }
@@ -2924,7 +2924,7 @@ namespace FEValuesViews
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         gradient_type return_value;
         return return_value;
       }
index 7cc9858b2bee97e8888a23e419b8f5ecb6b58ae3..5bde81b124deccd2e8b35ac2562b6f6c131bb0de 100644 (file)
@@ -1997,7 +1997,7 @@ namespace internal
                             cross_product_3d(data.aux[0][i], data.aux[1][i]);
                           break;
                         default:
-                          Assert(false, ExcNotImplemented());
+                          DEAL_II_NOT_IMPLEMENTED();
                       }
                 }
               else //(dim < spacedim)
@@ -2242,7 +2242,7 @@ namespace internal
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -2344,7 +2344,7 @@ namespace internal
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -2520,7 +2520,7 @@ namespace internal
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -2563,7 +2563,7 @@ namespace internal
               return;
             }
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
   } // namespace MappingQImplementation
index 94a6c36a55dbf229f023c98b5e4e6fddabb3f6a9..6d8f653b2c5de43ca964e806e25ab51fc38fab81 100644 (file)
@@ -50,7 +50,7 @@ namespace internal
       virtual unsigned int
       n_entities(const unsigned int d) const
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         (void)d;
 
         return 0;
@@ -62,7 +62,7 @@ namespace internal
       virtual dealii::ArrayView<const unsigned int>
       vertices_of_entity(const unsigned int d, const unsigned int e) const
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         (void)d;
         (void)e;
 
@@ -75,7 +75,7 @@ namespace internal
       virtual ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         (void)d;
         (void)e;
 
@@ -88,7 +88,7 @@ namespace internal
       virtual unsigned int
       n_lines_of_surface(const unsigned int face) const
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         (void)face;
 
         return 0;
@@ -101,7 +101,7 @@ namespace internal
       nth_line_of_surface(const unsigned int line,
                           const unsigned int face) const
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         (void)line;
         (void)face;
 
@@ -115,7 +115,7 @@ namespace internal
       vertices_of_nth_line_of_surface(const unsigned int line,
                                       const unsigned int face) const
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         (void)line;
         (void)face;
 
@@ -147,7 +147,7 @@ namespace internal
             return {table};
           }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return {};
       }
@@ -160,7 +160,7 @@ namespace internal
         if (d == 1)
           return ReferenceCells::Line;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return ReferenceCells::Vertex;
       }
@@ -201,7 +201,7 @@ namespace internal
             return {table[e]};
           }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return {};
       }
@@ -217,7 +217,7 @@ namespace internal
         if (d == 1)
           return ReferenceCells::Line;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return ReferenceCells::Vertex;
       }
@@ -258,7 +258,7 @@ namespace internal
             return {table[e]};
           }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return {};
       }
@@ -274,7 +274,7 @@ namespace internal
         if (d == 1)
           return ReferenceCells::Line;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return ReferenceCells::Vertex;
       }
@@ -323,7 +323,7 @@ namespace internal
             return {table[e]};
           }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return {};
       }
@@ -342,7 +342,7 @@ namespace internal
         if (d == 1)
           return ReferenceCells::Line;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return ReferenceCells::Vertex;
       }
@@ -434,7 +434,7 @@ namespace internal
             return {table[e]};
           }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return {};
       }
@@ -455,7 +455,7 @@ namespace internal
         if (d == 1)
           return ReferenceCells::Line;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return ReferenceCells::Vertex;
       }
@@ -560,7 +560,7 @@ namespace internal
             return {table[e]};
           }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return {};
       }
@@ -581,7 +581,7 @@ namespace internal
         if (d == 1)
           return ReferenceCells::Line;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return ReferenceCells::Vertex;
       }
@@ -688,7 +688,7 @@ namespace internal
             return {table[e]};
           }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return {};
       }
@@ -707,7 +707,7 @@ namespace internal
         if (d == 1)
           return ReferenceCells::Line;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return ReferenceCells::Vertex;
       }
@@ -890,7 +890,7 @@ namespace internal
         else if (from == 1 && to == 0)
           return line_vertices;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return cell_entities;
       }
@@ -909,7 +909,7 @@ namespace internal
         else if (from == 1 && to == 0)
           return line_vertices;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return cell_entities;
       }
index 8fd7263aa8f32179d2ed4faf5d38dbe4b64f0d1a..2214660cdc65bebf232017a7899b0b7350ef09fd 100644 (file)
@@ -874,7 +874,7 @@ namespace GridTools
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return projected_point;
       }
 
index dbde9f41213b235b7ee18b9575f5163104e889e2..e159dc9c00ceac83e8efb480832601100c6c87bd 100644 (file)
@@ -1101,7 +1101,7 @@ ReferenceCell::faces_for_given_vertex(const unsigned int vertex) const
       case ReferenceCells::Hexahedron:
         return {&GeometryInfo<3>::vertex_to_face[vertex][0], 3};
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return {};
@@ -1147,7 +1147,7 @@ ReferenceCell::get_dimension() const
       case ReferenceCells::Hexahedron:
         return 3;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1187,7 +1187,7 @@ ReferenceCell::n_vertices() const
       case ReferenceCells::Hexahedron:
         return 8;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1217,7 +1217,7 @@ ReferenceCell::n_lines() const
       case ReferenceCells::Hexahedron:
         return 12;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1337,10 +1337,10 @@ ReferenceCell::vertex(const unsigned int v) const
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return Point<dim>();
 }
 
@@ -1367,7 +1367,7 @@ ReferenceCell::n_faces() const
       case ReferenceCells::Hexahedron:
         return 6;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1401,14 +1401,14 @@ ReferenceCell::n_isotropic_children() const
       case ReferenceCells::Pyramid:
         // We haven't yet decided how to refine pyramids. Update this when we
         // have
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return numbers::invalid_unsigned_int;
       case ReferenceCells::Wedge:
         return 8;
       case ReferenceCells::Hexahedron:
         return 8;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1469,7 +1469,7 @@ ReferenceCell::face_reference_cell(const unsigned int face_no) const
       case ReferenceCells::Hexahedron:
         return ReferenceCells::Quadrilateral;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return ReferenceCells::Invalid;
@@ -1512,7 +1512,7 @@ ReferenceCell::child_cell_on_face(
       case ReferenceCells::Vertex:
       case ReferenceCells::Line:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           break;
         }
       case ReferenceCells::Triangle:
@@ -1539,7 +1539,7 @@ ReferenceCell::child_cell_on_face(
       case ReferenceCells::Pyramid:
       case ReferenceCells::Wedge:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           break;
         }
       case ReferenceCells::Hexahedron:
@@ -1556,7 +1556,7 @@ ReferenceCell::child_cell_on_face(
             face_rotation);
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1577,7 +1577,7 @@ ReferenceCell::standard_vertex_to_face_and_vertex_index(
     {
       case ReferenceCells::Vertex:
       case ReferenceCells::Line:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         break;
       case ReferenceCells::Triangle:
         {
@@ -1618,7 +1618,7 @@ ReferenceCell::standard_vertex_to_face_and_vertex_index(
             vertex);
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return {};
@@ -1639,7 +1639,7 @@ ReferenceCell::standard_line_to_face_and_line_index(
       case ReferenceCells::Triangle:
       case ReferenceCells::Quadrilateral:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           break;
         }
       case ReferenceCells::Tetrahedron:
@@ -1681,7 +1681,7 @@ ReferenceCell::standard_line_to_face_and_line_index(
           return GeometryInfo<3>::standard_hex_line_to_quad_line_index(line);
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return {};
@@ -1763,7 +1763,7 @@ ReferenceCell::line_to_cell_vertices(const unsigned int line,
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1785,7 +1785,7 @@ ReferenceCell::face_to_cell_lines(
     {
       case ReferenceCells::Vertex:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           break;
         }
       case ReferenceCells::Line:
@@ -1849,7 +1849,7 @@ ReferenceCell::face_to_cell_lines(
             face, line, face_orientation, face_flip, face_rotation);
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1878,7 +1878,7 @@ ReferenceCell::face_to_cell_vertices(
     {
       case ReferenceCells::Vertex:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           break;
         }
       case ReferenceCells::Line:
@@ -1950,7 +1950,7 @@ ReferenceCell::face_to_cell_vertices(
             face, vertex, face_orientation, face_flip, face_rotation);
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1982,7 +1982,7 @@ ReferenceCell::standard_to_real_face_vertex(
     {
       case ReferenceCells::Vertex:
       case ReferenceCells::Line:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         break;
       case ReferenceCells::Triangle:
       case ReferenceCells::Quadrilateral:
@@ -2004,10 +2004,10 @@ ReferenceCell::standard_to_real_face_vertex(
       case ReferenceCells::Hexahedron:
         return quadrilateral_vertex_permutations[face_orientation][vertex];
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return numbers::invalid_unsigned_int;
 }
 
@@ -2036,7 +2036,7 @@ ReferenceCell::standard_to_real_face_line(
       case ReferenceCells::Line:
       case ReferenceCells::Triangle:
       case ReferenceCells::Quadrilateral:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         break;
       case ReferenceCells::Tetrahedron:
         return triangle_table[combined_face_orientation][line];
@@ -2082,7 +2082,7 @@ ReferenceCell::standard_to_real_face_line(
           return table[combined_face_orientation][line];
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -2107,7 +2107,7 @@ namespace ReferenceCells
         case 3:
           return ReferenceCells::Tetrahedron;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return ReferenceCells::Invalid;
   }
@@ -2129,7 +2129,7 @@ namespace ReferenceCells
         case 3:
           return ReferenceCells::Hexahedron;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return ReferenceCells::Invalid;
   }
@@ -2258,7 +2258,7 @@ ReferenceCell::d_linear_shape_function(const Point<dim>  &xi,
                  .d_linear_shape_function<1>(Point<1>(xi[std::min(2, dim - 1)]),
                                              i / 3);
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return 0.0;
@@ -2293,7 +2293,7 @@ ReferenceCell::d_linear_shape_function_gradient(const Point<dim>  &xi,
               Assert(false, ExcInternalError());
           }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return Point<dim>(+0.0, +0.0, +0.0);
@@ -2323,7 +2323,7 @@ ReferenceCell::volume() const
       case ReferenceCells::Hexahedron:
         return 1;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return 0.0;
@@ -2356,7 +2356,7 @@ ReferenceCell::barycenter() const
       case ReferenceCells::Hexahedron:
         return Point<dim>(1. / 2., 1. / 2., 1. / 2.);
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return Point<dim>();
@@ -2465,7 +2465,7 @@ ReferenceCell::contains_point(const Point<dim> &p, const double tolerance) const
           return true;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return false;
@@ -2545,7 +2545,7 @@ ReferenceCell::unit_tangential_vectors(const unsigned int face_no,
           return table[face_no][i];
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -2578,7 +2578,7 @@ ReferenceCell::unit_normal_vectors(const unsigned int face_no) const
                               unit_tangential_vectors<dim>(face_no, 1));
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return {};
 }
@@ -2865,7 +2865,7 @@ ReferenceCell::get_combined_orientation(
           return 6;
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   Assert(false, (internal::NoPermutation<T>(*this, vertices_0, vertices_1)));
@@ -2922,7 +2922,7 @@ ReferenceCell::permute_by_combined_orientation(
             case 0:
               return {vertices[1], vertices[0]};
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         break;
       case ReferenceCells::Triangle:
@@ -2941,7 +2941,7 @@ ReferenceCell::permute_by_combined_orientation(
             case 4:
               return {vertices[1], vertices[0], vertices[2]};
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         break;
       case ReferenceCells::Quadrilateral:
@@ -2964,7 +2964,7 @@ ReferenceCell::permute_by_combined_orientation(
             case 6:
               return {vertices[1], vertices[0], vertices[3], vertices[2]};
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         break;
       default:
index 2466498a59752ad84e0d7f558f90f0f0bbe78b01..026e698a2059d8e00e1b93e917f63251248c48e7 100644 (file)
@@ -113,7 +113,7 @@ namespace internal
                          (vertices[2] - vertices[5]).norm(),
                          (vertices[3] - vertices[4]).norm()});
 
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return -1e10;
     }
   } // namespace TriaAccessorImplementation
@@ -935,7 +935,7 @@ namespace internal
       {
         // it seems like we don't need this
         // one
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
 
@@ -1572,7 +1572,7 @@ TriaAccessor<structdim, dim, spacedim>::isotropic_child_index(
         }
 
       case 3:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return -1;
 }
@@ -1694,7 +1694,7 @@ TriaAccessor<structdim, dim, spacedim>::isotropic_child(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   // we don't get here but have to return
   // something...
@@ -2099,7 +2099,7 @@ TriaAccessor<structdim, dim, spacedim>::set_all_boundary_ids(
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -2176,7 +2176,7 @@ TriaAccessor<structdim, dim, spacedim>::set_all_manifold_ids(
           this->line(i)->set_manifold_id(manifold_ind);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -2302,7 +2302,7 @@ TriaAccessor<structdim, dim, spacedim>::enclosing_ball() const
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return std::pair<Point<spacedim>, double>();
     }
 
@@ -2365,7 +2365,7 @@ TriaAccessor<structdim, dim, spacedim>::minimum_vertex_distance() const
           return std::sqrt(min);
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return -1e10;
     }
 }
@@ -3009,7 +3009,7 @@ template <int spacedim>
 inline void
 TriaAccessor<0, 1, spacedim>::operator++() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3017,7 +3017,7 @@ template <int spacedim>
 inline void
 TriaAccessor<0, 1, spacedim>::operator--() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index abe324c012931d3b06a451fd0e50ba9563b33ac3..f7f50dbde8b8c31026774f3be3c3f89dfaa416af 100644 (file)
@@ -163,7 +163,7 @@ namespace hp
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
   }
 
index 88d79cf95fafe7aa96e88096ec7ff8b770cbc916..1d923ab9549ed7409cd54eebcc30a4de96f0fde4 100644 (file)
@@ -106,7 +106,7 @@ namespace LocalIntegrators
             result[2] = h0[2][0] + h1[2][1] - h2[0][0] - h2[1][1];
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       return result;
     }
@@ -145,7 +145,7 @@ namespace LocalIntegrators
               normal[1] * (g1[0] - g2[1]) + normal[0] * (g0[2] - g2[0]);
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       return result;
     }
index 305a39828cc1fdac92588aa69af2ba8bcf5a2b24..85d982c8c77455a58870b364a7323d48fd7acdfb 100644 (file)
@@ -2906,7 +2906,7 @@ AffineConstraints<number>::merge(
                   break;
 
                 default:
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
               }
           }
       }
index 588d076ae5d46e7afd04c99c2ff2aa3ed6e7f971..8d701603000871d39030e94b5f62ad49778d11b0 100644 (file)
@@ -4766,7 +4766,7 @@ AffineConstraints<number>::add_entries_local_to_global(
     }
 
   // TODO: implement this
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index 4e2f3861c30335375c8b38b09c931d1c5b46180e..178f8f852a5def6f0f7aec012ae9cb55b2d1ef17 100644 (file)
@@ -50,7 +50,7 @@ omatcopy(char,
          number3 *,
          dealii::types::blas_int)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index 2eca5897c5f6f7e477ae67a829de5b0925a79545..df1e7b7749907455df577cab541629548493b200 100644 (file)
@@ -520,7 +520,7 @@ ChunkSparseMatrix<number>::symmetrize()
   Assert(cols != nullptr, ExcNeedsSparsityPattern());
   Assert(cols->rows == cols->cols, ExcNotQuadratic());
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1222,7 +1222,7 @@ ChunkSparseMatrix<number>::precondition_Jacobi(Vector<somenumber>       &dst,
   Assert(dst.size() == n(), ExcDimensionMismatch(dst.size(), n()));
   Assert(src.size() == n(), ExcDimensionMismatch(src.size(), n()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1246,7 +1246,7 @@ ChunkSparseMatrix<number>::precondition_SSOR(Vector<somenumber>       &dst,
   Assert(dst.size() == n(), ExcDimensionMismatch(dst.size(), n()));
   Assert(src.size() == n(), ExcDimensionMismatch(src.size(), n()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1299,7 +1299,7 @@ ChunkSparseMatrix<number>::SOR(Vector<somenumber> &dst,
          ExcMessage("This operation is only valid on square matrices."));
   Assert(m() == dst.size(), ExcDimensionMismatch(m(), dst.size()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1316,7 +1316,7 @@ ChunkSparseMatrix<number>::TSOR(Vector<somenumber> &dst,
          ExcMessage("This operation is only valid on square matrices."));
   Assert(m() == dst.size(), ExcDimensionMismatch(m(), dst.size()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1343,7 +1343,7 @@ ChunkSparseMatrix<number>::PSOR(
   Assert(m() == inverse_permutation.size(),
          ExcDimensionMismatch(m(), inverse_permutation.size()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1370,7 +1370,7 @@ ChunkSparseMatrix<number>::TPSOR(
   Assert(m() == inverse_permutation.size(),
          ExcDimensionMismatch(m(), inverse_permutation.size()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1392,7 +1392,7 @@ ChunkSparseMatrix<number>::SOR_step(Vector<somenumber>       &v,
   Assert(m() == v.size(), ExcDimensionMismatch(m(), v.size()));
   Assert(m() == b.size(), ExcDimensionMismatch(m(), b.size()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1414,7 +1414,7 @@ ChunkSparseMatrix<number>::TSOR_step(Vector<somenumber>       &v,
   Assert(m() == v.size(), ExcDimensionMismatch(m(), v.size()));
   Assert(m() == b.size(), ExcDimensionMismatch(m(), b.size()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1446,7 +1446,7 @@ ChunkSparseMatrix<number>::SSOR(Vector<somenumber> &dst,
 
   Assert(m() == dst.size(), ExcDimensionMismatch(m(), dst.size()));
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1460,7 +1460,7 @@ ChunkSparseMatrix<number>::print(std::ostream &out) const
   Assert(cols != nullptr, ExcNeedsSparsityPattern());
   Assert(val != nullptr, ExcNotInitialized());
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   AssertThrow(out.fail() == false, ExcIO());
 }
@@ -1483,7 +1483,7 @@ ChunkSparseMatrix<number>::print_formatted(std::ostream      &out,
 
   unsigned int width = width_;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   std::ios::fmtflags old_flags     = out.flags();
   unsigned int       old_precision = out.precision(precision);
index e4d021cc9e05f094e7e0d4290fcec0b1575f74a7..d949c5af963ec176e00ba725f999b889210a7446 100644 (file)
@@ -967,7 +967,7 @@ namespace DynamicSparsityPatternIterators
     (void)other;
     Assert(accessor.sparsity_pattern == other.accessor.sparsity_pattern,
            ExcInternalError());
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
     return 0;
   }
index 9d673c1ba84ae7907c76b29bd869c5b8918539ef..13ce9ce3e08fc2f4110afbd3f6b5c0a622438ec8 100644 (file)
@@ -343,7 +343,7 @@ template <typename VectorType>
 void
 Householder<number>::Tvmult(VectorType &, const VectorType &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index 9eed721d4ad36094792695ad721fbf1b5f4f4aee..4d2be1fd24a7042176225e6f867eb94c0c49a3d0 100644 (file)
@@ -143,7 +143,7 @@ namespace LAPACKSupport
           return "Hessenberg";
       }
 
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return "invalid";
   }
 
index 966ac3dcee6b29de46b637387bbc1ea7ea23df13..9f1c2d36d47ec863967216702b90a69cf09858d0 100644 (file)
@@ -1409,7 +1409,7 @@ axpy(const dealii::types::blas_int *,
      number3 *,
      const dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1528,7 +1528,7 @@ geev(const char *,
      const dealii::types::blas_int *,
      dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1728,7 +1728,7 @@ geevx(const char *,
       dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2068,7 +2068,7 @@ gelsd(const dealii::types::blas_int *,
       dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2257,7 +2257,7 @@ gemm(const char *,
      number5 *,
      const dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2432,7 +2432,7 @@ gemv(const char *,
      number5 *,
      const dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2584,7 +2584,7 @@ geqrf(const dealii::types::blas_int *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2718,7 +2718,7 @@ gesdd(const char *,
       dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2908,7 +2908,7 @@ gesvd(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3086,7 +3086,7 @@ getrf(const dealii::types::blas_int *,
       dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3193,7 +3193,7 @@ getri(const dealii::types::blas_int *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3310,7 +3310,7 @@ getrs(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3439,7 +3439,7 @@ template <typename number1>
 inline number1
 lamch(const char *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return number1();
 }
 
@@ -3484,7 +3484,7 @@ lange(const char *,
       const dealii::types::blas_int *,
       number2 *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return number1();
 }
 
@@ -3595,7 +3595,7 @@ lansy(const char *,
       const dealii::types::blas_int *,
       number2 *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return number1();
 }
 
@@ -3710,7 +3710,7 @@ lascl(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3855,7 +3855,7 @@ orgqr(const dealii::types::blas_int *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3939,7 +3939,7 @@ ormqr(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4035,7 +4035,7 @@ pocon(const char *,
       dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4168,7 +4168,7 @@ potrf(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4265,7 +4265,7 @@ potri(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4365,7 +4365,7 @@ potrs(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4492,7 +4492,7 @@ stev(const char *,
      number4 *,
      dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4563,7 +4563,7 @@ syev(const char *,
      const dealii::types::blas_int *,
      dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4658,7 +4658,7 @@ syevr(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4862,7 +4862,7 @@ syevx(const char *,
       dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -5027,7 +5027,7 @@ sygv(const dealii::types::blas_int *,
      const dealii::types::blas_int *,
      dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -5137,7 +5137,7 @@ sygvx(const dealii::types::blas_int *,
       dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -5312,7 +5312,7 @@ syr(const char *,
     number3 *,
     const dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -5383,7 +5383,7 @@ syrk(const char *,
      number4 *,
      const dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -5529,7 +5529,7 @@ trcon(const char *,
       dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -5673,7 +5673,7 @@ trmv(const char *,
      number2 *,
      const dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -5799,7 +5799,7 @@ trtrs(const char *,
       const dealii::types::blas_int *,
       dealii::types::blas_int *)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index cd1e500f9cc072f7ade31a13874bbdbaff87b5c0..86fc5a7ebf8326f9c7a86b25713a153512d9e20f 100644 (file)
@@ -869,7 +869,7 @@ MatrixBlockVector<MatrixType>::clear(bool really_clean)
 {
   if (really_clean)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
   else
     {
@@ -1121,7 +1121,7 @@ MGMatrixBlockVector<MatrixType>::clear(bool really_clean)
 {
   if (really_clean)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
   else
     {
index 526b77cbeedc6680831b4ff938804f592e56316f..a5b3591a696aa6f0b0f21826ebbf54b099d4ece0 100644 (file)
@@ -3603,7 +3603,7 @@ PreconditionChebyshev<MatrixType, VectorType, PreconditionerType>::
               data.eig_cg_n_iterations));
         }
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
       // read the eigenvalues from the attached eigenvalue tracker
       if (eigenvalue_tracker.values.empty())
index cbd6ab20f1b1a74be5de5085a56c863da96031b7..220f5ba338d57235e2d496cf4d95fb6193802b75 100644 (file)
@@ -152,7 +152,7 @@ PreconditionBlock<MatrixType, inverse_type>::invert_permuted_diagblocks()
             this->inverse_svd(0).compute_inverse_svd(0.);
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
   else
@@ -207,7 +207,7 @@ PreconditionBlock<MatrixType, inverse_type>::invert_permuted_diagblocks()
                 this->inverse_svd(cell).compute_inverse_svd(0.);
                 break;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
     }
@@ -459,7 +459,7 @@ PreconditionBlock<MatrixType, inverse_type>::invert_diagblocks()
             this->inverse_svd(0).compute_inverse_svd(1.e-12);
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
   else
@@ -502,7 +502,7 @@ PreconditionBlock<MatrixType, inverse_type>::invert_diagblocks()
                 this->inverse_svd(cell).compute_inverse_svd(1.e-12);
                 break;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
     }
index 6a1b4c76dc0a7a1f6de5a4cf9da6b4286ee3ff10..4ec494d6d061551a1382cd74f9b337e777c7e593 100644 (file)
@@ -356,7 +356,7 @@ PreconditionBlockBase<number>::reinit(unsigned int n,
             var_inverse_svd[0].reinit(b, b);
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       if (store_diagonals())
@@ -400,7 +400,7 @@ PreconditionBlockBase<number>::reinit(unsigned int n,
               break;
             }
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -437,7 +437,7 @@ PreconditionBlockBase<number>::inverse_vmult(size_type              i,
         var_inverse_svd[ii].vmult(dst, src);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -466,7 +466,7 @@ PreconditionBlockBase<number>::inverse_Tvmult(size_type              i,
         var_inverse_svd[ii].Tvmult(dst, src);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -657,7 +657,7 @@ PreconditionBlockBase<number>::log_statistics() const
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
index e89fd41badee131f01f21a3739174e7b08ed17e4..e2ffae0f41a617fb6fb8a9a51cebba2bc7f99591 100644 (file)
@@ -272,7 +272,7 @@ PreconditionSelector<MatrixType, VectorType>::vmult(VectorType       &dst,
           A->precondition_SSOR(dst, src, omega);
         }
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -304,7 +304,7 @@ PreconditionSelector<MatrixType, VectorType>::Tvmult(
           A->precondition_SSOR(dst, src, omega); // Symmetric operation
         }
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
index abc2e8561070937a76d1cabb1cd681fbdc53a2c4..5fbc9796c5aa466d54556c3ad7f192eb4bf9b402 100644 (file)
@@ -94,7 +94,7 @@ RelaxationBlock<MatrixType, InverseNumberType, VectorType>::invert_diagblocks()
 {
   if (this->same_diagonal())
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
   else
     {
@@ -169,7 +169,7 @@ RelaxationBlock<MatrixType, InverseNumberType, VectorType>::block_kernel(
                 this->additional_data->threshold);
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
index c1c97cae506c7f590490555b8d770b0347d5b3be..09b8fd8e3f2a9e716d4f1d4e440720c71512943c 100644 (file)
@@ -1847,7 +1847,7 @@ SparseMatrix<number>::SSOR(Vector<somenumber> &dst, const number omega) const
 {
   // TODO: Is this called anywhere? If so, multiplication with omega(2-omega)D
   // is missing
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   Assert(cols != nullptr, ExcNeedsSparsityPattern());
   Assert(val != nullptr, ExcNotInitialized());
index 4aee5b84dca84c2d662b410c1878dd5d4780aa66..8727a9770505a19aee0717af4bc0a931c3de2fe1 100644 (file)
@@ -877,7 +877,7 @@ namespace internal
         }
 
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
 
index 4c16d8b8791be0d615816861effcec7f4238db73..631c4145cc7a4d751174ea193d23eb453e11ba19 100644 (file)
@@ -1145,7 +1145,7 @@ namespace TrilinosWrappers
                      Teuchos::SerialDenseMatrix<int, value_type> &,
                      const bool = false)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
       virtual int
@@ -1153,7 +1153,7 @@ namespace TrilinosWrappers
         Teuchos::SerialDenseMatrix<int, value_type> &,
         const typename Teuchos::ScalarTraits<value_type>::magnitudeType &)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
 #      endif
index 9f566733fabd8111591b359708e4bf163b747dd9..43a0a4946d809b708797e029b495b353f02f6a1c 100644 (file)
@@ -416,7 +416,7 @@ namespace LinearAlgebra
       else if (operation == VectorOperation::add)
         tpetra_operation = Tpetra::ADD;
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
       vector->doExport(source_vector, *tpetra_export, tpetra_operation);
     }
@@ -875,7 +875,7 @@ namespace LinearAlgebra
           else if (operation == VectorOperation::add)
             tpetra_operation = Tpetra::ADD;
           else
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
 
           Teuchos::RCP<const ExportType> exporter =
             Tpetra::createExport(nonlocal_vector->getMap(), vector->getMap());
index b1cf07adce9cc8c67d79dce71b1b2961c7367221..3ddfef8fa76c1fb383069eb9e926a87d7f64c099 100644 (file)
@@ -134,7 +134,7 @@ namespace internal
                   values_quad[0] = values_dofs[0];
                   break;
                 default:
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
               }
             // Note: we always keep storage of values, 1st and 2nd derivatives
             // in an array
@@ -333,7 +333,7 @@ namespace internal
                   values_dofs[0] = values_quad[0];
                   break;
                 default:
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
               }
             values_dofs += 3 * n_dofs;
             values_quad += n_q_points;
@@ -558,7 +558,7 @@ namespace internal
       // TODO: This is currently not implemented, but the test
       // matrix_vector_rt_face_03 apparently works without it -> check
       // if (subface_index < GeometryInfo<dim - 1>::max_children_per_cell)
-      //  Assert(false, ExcNotImplemented());
+      //  DEAL_II_NOT_IMPLEMENTED();
 
       using Eval = EvaluatorTensorProduct<evaluate_evenodd,
                                           dim - 1,
@@ -2374,7 +2374,7 @@ namespace internal
                   }
                 else
                   {
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                   }
               }
             else if (n_face_orientations == n_lanes)
index ef1e59afdce332293ed96ab760539c4bae124b02..2612800ff60d24eee939bb8da8492720df588518 100644 (file)
@@ -449,7 +449,7 @@ namespace internal
         }
       else
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
   };
@@ -1689,7 +1689,7 @@ namespace internal
                 }
               else
                 {
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
                 }
             }
 
index cf135ebd5430d6d8775a61736fe23633b22e5e47..04b004defe6589879ae26883b53fc01f4da7bea8 100644 (file)
@@ -4747,7 +4747,7 @@ FEEvaluationBase<dim, n_components_, Number, is_face, VectorizedArrayType>::
                   (jac[1][1] * jac[2][2]);
                 break;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
           for (unsigned int d = 0; d < dim; ++d)
             for (unsigned int e = d + 1; e < dim; ++e)
@@ -6190,7 +6190,7 @@ FEEvaluationAccess<dim, dim, Number, is_face, VectorizedArrayType>::
         symmetrized[5] *= half;
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return SymmetricTensor<2, dim, VectorizedArrayType>(symmetrized);
 }
@@ -6222,7 +6222,7 @@ inline DEAL_II_ALWAYS_INLINE
         curl[2] = grad[1][0] - grad[0][1];
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return curl;
 }
@@ -6731,7 +6731,7 @@ FEEvaluationAccess<dim, dim, Number, is_face, VectorizedArrayType>::submit_curl(
         grad[0][1] = -curl[2];
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   submit_gradient(grad, q_point);
 }
index 5e1a4b2fcfe061d9c63c80d0d17891310ca868f3..11bf9f874a81cde786ca2aa1f5200cedefad68a7 100644 (file)
@@ -1040,7 +1040,7 @@ FERemoteEvaluation<dim, n_components, value_type>::gather_evaluate(
                                                        evaluation_flags);
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 template <int dim, int n_components, typename value_type>
index 03b6596820d9ebb099c2f952472701455b301f77..5b8bd3e907a11316b3e538cb28d353ce2386ebeb 100644 (file)
@@ -682,10 +682,10 @@ namespace internal
               case 2:
                 return n_dofs_1d * n_dofs_1d * offset + n_dofs_1d * i + j;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return 0;
       };
@@ -768,7 +768,7 @@ namespace internal
                     }
                   else
                     {
-                      Assert(false, ExcNotImplemented());
+                      DEAL_II_NOT_IMPLEMENTED();
                     }
 
                   // update DoF map
index 5834f41fb054095d5d0efbb7d228885f2bd6d52b..882a2a5b1b180c54a4abe9bc9077ef7f5eb40fe0 100644 (file)
@@ -2301,7 +2301,7 @@ namespace internal
                     boundary_form = cross_product_3d(tangential_vectors[0],
                                                      tangential_vectors[1]);
                   else
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
 
                   const VectorizedDouble JxW =
                     boundary_form.norm() *
@@ -3215,7 +3215,7 @@ namespace internal
                           }
                       if (update_flags & update_jacobian_grads)
                         {
-                          Assert(false, ExcNotImplemented());
+                          DEAL_II_NOT_IMPLEMENTED();
                         }
                       if (update_flags & update_normal_vectors)
                         for (unsigned int d = 0; d < dim; ++d)
@@ -3268,7 +3268,7 @@ namespace internal
                           }
                       if (update_flags & update_jacobian_grads)
                         {
-                          Assert(false, ExcNotImplemented());
+                          DEAL_II_NOT_IMPLEMENTED();
                         }
                       if (update_flags & update_normal_vectors)
                         for (unsigned int q = 0; q < fe_val.n_quadrature_points;
index 94c7622e37981616dee4573057435daca8bfa1d0..83b2639105e36f2e77dacccf28c48277d6ea7276 100644 (file)
@@ -133,7 +133,7 @@ namespace internal
           // FE_Nothing case -> nothing to do here
         }
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
       // Finally store the renumbering into the respective field
       if (fe_in.n_components() == 1)
index 27fbd6403ce6dc31110f9c1cbc677a98286de510..7270bb32f7752652275e62715ffed29a223195e8 100644 (file)
@@ -425,7 +425,7 @@ namespace internal
       VectorizedArrayType *,
       std::bool_constant<false>) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -674,7 +674,7 @@ namespace internal
       VectorizedArrayType *,
       std::bool_constant<false>) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -910,7 +910,7 @@ namespace internal
       VectorizedArrayType *,
       std::bool_constant<false>) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
index 4803b0ebec1fea59cb7399c1d59e66ba384334e2..33423f683b0a4ca04ef303c6218b25cc5c11f033 100644 (file)
@@ -56,7 +56,7 @@ namespace MeshWorker
     const unsigned int,
     const unsigned int) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -74,7 +74,7 @@ namespace MeshWorker
     const unsigned int,
     const unsigned int) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
index 36a9b48e926e2ec1c3cc33f5e12513355efcd145..bdf21af886f9976e0d77a58d5f7fae7d8465c933 100644 (file)
@@ -2716,7 +2716,7 @@ namespace MGTransferGlobalCoarseningTools
       coarse_grid_triangulations(fine_triangulation_in.n_global_levels());
 
 #ifndef DEAL_II_WITH_P4EST
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     (void)policy;
     (void)keep_fine_triangulation;
     (void)repartition_fine_triangulation;
@@ -3809,7 +3809,7 @@ MGTransferMF<dim, Number>::get_dof_handler_fine() const
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {nullptr, numbers::invalid_unsigned_int};
     }
 }
index 01805e012ee096dd6649b19ae740bc605b6ca8a2..bfa48542bae279fc0886d783df7db6666d89f7d1 100644 (file)
@@ -966,7 +966,7 @@ PreconditionMG<dim, VectorType, TransferType>::Tvmult(
   OtherVectorType &,
   const OtherVectorType &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -977,7 +977,7 @@ PreconditionMG<dim, VectorType, TransferType>::Tvmult_add(
   OtherVectorType &,
   const OtherVectorType &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index c9441fa2e73799bfeded48bd433b7d4f8cb4c94d..3f258ecd64d953f2fd263b770aa161d646a4d63b 100644 (file)
@@ -97,7 +97,7 @@ namespace internal
     {
       (void)n_subdivisions;
 
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
 
       return {};
     }
@@ -353,7 +353,7 @@ namespace internal
                       else if (reference_cell == ReferenceCells::Pyramid)
                         quadrature.push_back(*quadrature_pyramid);
                       else
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
                     }
 
                   x_fe_values[i] =
@@ -1532,7 +1532,7 @@ namespace internal
         const ComponentExtractor /*extract_component*/,
         std::vector<Tensor<1, spacedim>> & /*patch_gradients*/) const override
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
       /**
@@ -1547,7 +1547,7 @@ namespace internal
         std::vector<std::vector<Tensor<1, spacedim>>>
           & /*patch_gradients_system*/) const override
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
 
@@ -1561,7 +1561,7 @@ namespace internal
         const ComponentExtractor /*extract_component*/,
         std::vector<Tensor<2, spacedim>> & /*patch_hessians*/) const override
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
       /**
@@ -1576,7 +1576,7 @@ namespace internal
         std::vector<std::vector<Tensor<2, spacedim>>>
           & /*patch_hessians_system*/) const override
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
       /**
@@ -1636,7 +1636,7 @@ namespace internal
       const unsigned int       cell_number,
       const ComponentExtractor extract_component) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
 
       (void)cell_number;
       (void)extract_component;
@@ -2375,7 +2375,7 @@ DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
   // note that we do not have to traverse the list of cell data here because
@@ -2454,7 +2454,7 @@ DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::get_fes() const
               std::make_shared<dealii::hp::FECollection<dim, spacedim>>(
                 FE_PyramidDGP<dim, spacedim>(1)));
           else
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
   return finite_elements;
index 42b105f1717ca0fe43f92600239551a86e8e6052..dcc74f22f97e1547d8d8dab322c17450683602cb 100644 (file)
@@ -512,7 +512,7 @@ namespace internal
           }
         default:
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return std::numeric_limits<double>::lowest();
           }
       }
@@ -556,7 +556,7 @@ namespace internal
           }
         default:
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return std::numeric_limits<double>::lowest();
           }
       }
@@ -602,7 +602,7 @@ namespace internal
           }
         default:
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return std::numeric_limits<double>::lowest();
           }
       }
@@ -637,7 +637,7 @@ namespace internal
           }
         default:
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return std::numeric_limits<double>::lowest();
           }
       }
index ab7e36e9aa2fac13694404a9e8399c8d52efd1ae..16e2ae070add78eeeda75cc1a99e801f0d954c39 100644 (file)
@@ -119,7 +119,7 @@ namespace MatrixCreator
         Scratch &
         operator=(const Scratch &)
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return *this;
         }
 
@@ -1101,11 +1101,11 @@ namespace MatrixCreator
                     if (!base.conforms(FiniteElementData<dim>::H1) &&
                         base.conforms(FiniteElementData<dim>::Hdiv) &&
                         fe_is_primitive)
-                      Assert(false, ExcNotImplemented());
+                      DEAL_II_NOT_IMPLEMENTED();
 
                     if (!base.conforms(FiniteElementData<dim>::H1) &&
                         base.conforms(FiniteElementData<dim>::Hcurl))
-                      Assert(false, ExcNotImplemented());
+                      DEAL_II_NOT_IMPLEMENTED();
 
                     if (!base.conforms(FiniteElementData<dim>::H1) &&
                         base.conforms(FiniteElementData<dim>::Hdiv))
@@ -1307,7 +1307,7 @@ namespace MatrixCreator
       const Function<3, float> *const /*coefficient*/,
       const std::vector<unsigned int> & /*component_mapping*/)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
     template <>
@@ -1324,7 +1324,7 @@ namespace MatrixCreator
       const Function<3, double> *const /*coefficient*/,
       const std::vector<unsigned int> & /*component_mapping*/)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
   } // namespace internal
@@ -1350,7 +1350,7 @@ namespace MatrixCreator
     // dofs?
     if (dim == 1)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return;
       }
 
@@ -1552,11 +1552,11 @@ namespace MatrixCreator
                     if (!base.conforms(FiniteElementData<dim>::H1) &&
                         base.conforms(FiniteElementData<dim>::Hdiv) &&
                         fe_is_primitive)
-                      Assert(false, ExcNotImplemented());
+                      DEAL_II_NOT_IMPLEMENTED();
 
                     if (!base.conforms(FiniteElementData<dim>::H1) &&
                         base.conforms(FiniteElementData<dim>::Hcurl))
-                      Assert(false, ExcNotImplemented());
+                      DEAL_II_NOT_IMPLEMENTED();
 
                     if (!base.conforms(FiniteElementData<dim>::H1) &&
                         base.conforms(FiniteElementData<dim>::Hdiv))
@@ -1825,7 +1825,7 @@ namespace MatrixCreator
     // dofs?
     if (dim == 1)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return;
       }
 
index 18ae6ed1115e7a0a7d2e1285da7a4ed987ed30d9..533253009d6a7ad83259ee129369a656280dc42f 100644 (file)
@@ -1154,7 +1154,7 @@ namespace VectorTools
               dof_is_of_interest = true;
             }
           else
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
 
           if (dof_is_of_interest)
             {
@@ -1590,7 +1590,7 @@ namespace VectorTools
                           dof_is_of_interest = true;
                         }
                       else
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
 
                       if (dof_is_of_interest)
                         {
@@ -1780,7 +1780,7 @@ namespace VectorTools
               break;
             }
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -2081,7 +2081,7 @@ namespace VectorTools
               break;
             }
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -2233,7 +2233,7 @@ namespace VectorTools
       const std::vector<DerivativeForm<1, dim, dim>> &,
       AffineConstraints<number> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
     // This function computes the projection of the boundary function on the
@@ -2339,7 +2339,7 @@ namespace VectorTools
       std::vector<number> &,
       std::vector<types::global_dof_index> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
   } // namespace internals
 
@@ -2512,7 +2512,7 @@ namespace VectorTools
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   }
 
@@ -2670,7 +2670,7 @@ namespace VectorTools
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   }
 } // namespace VectorTools
index 9785674a98954cf0e2462405cfbf6408ff477c25..643d4f0bf182d5137e2b40e58bd7aab7fbcbb532 100644 (file)
@@ -337,7 +337,7 @@ namespace VectorTools
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -508,7 +508,7 @@ namespace VectorTools
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -1209,7 +1209,7 @@ namespace VectorTools
                               cross_product_3d(normals[0], normals[dim - 2]);
                             break;
                           default:
-                            Assert(false, ExcNotImplemented());
+                            DEAL_II_NOT_IMPLEMENTED();
                         }
 
                       Assert(
index c33c060dd158c9380073017187aa57eeb9cc0ee0..1e9ab401dea8d558287b0551cf6482adf457f782 100644 (file)
@@ -376,7 +376,7 @@ namespace VectorTools
           case EvaluationFlags::insert:
             return values[0];
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return values[0];
         }
     }
@@ -403,7 +403,7 @@ namespace VectorTools
           case EvaluationFlags::insert:
             return values[0];
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return values[0];
         }
     }
@@ -439,7 +439,7 @@ namespace VectorTools
           case EvaluationFlags::insert:
             return values[0];
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return values[0];
         }
     }
index 13c04d0e0b095cb3ed02de3cea12cac71a52491b..513c433c501e9edcaed347f8f050ded01cd9a9a1 100644 (file)
@@ -333,7 +333,7 @@ namespace VectorTools
             break;
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             break;
         }
 
index 6d86f03462dd612424a12f51d5f6eae2d1dd0337..951fb22983f546dd5153bf38a710863eb9f080af 100644 (file)
@@ -1091,7 +1091,7 @@ namespace TrilinosWrappers
                 "solve_with_jacobian_and_track_n_linear_iterations function "
                 "has been attached to the NOXSolver object."));
 
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             ret_code = 1;
           }
 
index 4410e43a38711b026b04c17cdf255ba11a6b7663..3de710201ada1603d3a0ce3cc6c6512281bd973c 100644 (file)
@@ -116,7 +116,7 @@ AutoDerivativeFunction<dim>::gradient(const Point<dim>  &p,
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return grad;
 }
@@ -194,7 +194,7 @@ AutoDerivativeFunction<dim>::vector_gradient(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -257,7 +257,7 @@ AutoDerivativeFunction<dim>::gradient_list(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -326,7 +326,7 @@ AutoDerivativeFunction<dim>::vector_gradient_list(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -346,7 +346,7 @@ AutoDerivativeFunction<dim>::get_formula_of_order(const unsigned int ord)
       case 4:
         return FourthOrder;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return Euler;
 }
index 098b08fd29ef7a97c5c518330e207a4d9e689c6b..83b0167bb75ede8d1b1688908638ac1cf5db5ae4 100644 (file)
@@ -96,7 +96,7 @@ namespace
         case (DataOutBase::CompressionLevel::default_compression):
           return Z_DEFAULT_COMPRESSION;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return Z_NO_COMPRESSION;
       }
   }
@@ -120,7 +120,7 @@ namespace
         case (DataOutBase::CompressionLevel::default_compression):
           return boost::iostreams::zlib::default_compression;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return boost::iostreams::zlib::no_compression;
       }
   }
@@ -626,7 +626,7 @@ namespace DataOutBase
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   }
 
@@ -757,7 +757,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
     return vtk_cell_id;
@@ -814,7 +814,7 @@ namespace
               break;
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         Point<spacedim> node;
         for (unsigned int d = 0; d < spacedim; ++d)
@@ -1514,7 +1514,7 @@ namespace
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     stream << '\n';
   }
@@ -1586,7 +1586,7 @@ namespace
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     stream << '\n';
   }
@@ -1714,7 +1714,7 @@ namespace
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     stream << '\n';
   }
@@ -2525,7 +2525,7 @@ namespace DataOutBase
         case svg:
           return ".svg";
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return "";
       }
   }
@@ -2701,7 +2701,7 @@ namespace DataOutBase
                     break;
                   }
                 default:
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
               }
 
             // Update the number of the first vertex of this patch
@@ -2809,7 +2809,7 @@ namespace DataOutBase
                     break;
                   }
                 default:
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
               }
 
             // Having so set up the 'connectivity' data structure,
@@ -3928,13 +3928,13 @@ namespace DataOutBase
                   }
                 else
                   // No other reference cells are currently implemented
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
 
                 break;
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
     // make sure everything now gets to disk
@@ -4428,7 +4428,7 @@ namespace DataOutBase
                       heights[i] = points[i][2];
                     break;
                   default:
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                 }
 
 
@@ -4854,7 +4854,7 @@ namespace DataOutBase
             out << "\"x\", \"y\", \"z\"";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       for (unsigned int data_set = 0; data_set < n_data_sets; ++data_set)
@@ -5636,7 +5636,7 @@ namespace DataOutBase
                         }
 
                       default:
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
                     }
                 }
               else // use higher-order output
@@ -5724,7 +5724,7 @@ namespace DataOutBase
                           break;
                         }
                       default:
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
                     }
                 }
 
@@ -6379,7 +6379,7 @@ namespace DataOutBase
     const SvgFlags &,
     std::ostream &)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
   template <int spacedim>
@@ -8843,7 +8843,7 @@ DataOutInterface<dim, spacedim>::write(
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -8891,7 +8891,7 @@ DataOutInterface<dim, spacedim>::set_flags(const FlagType &flags)
     deal_II_intermediate_flags =
       *reinterpret_cast<const DataOutBase::Deal_II_IntermediateFlags *>(&flags);
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index a7832a8262edd9bb53a4f9d4056ff64da06e38c3..5bdbd85462a4b30163a7dabcda43e430b2a9692c 100644 (file)
@@ -187,7 +187,7 @@ ExceptionBase::print_exc_data(std::ostream &out) const
 
   // If the exception stores a string representation of the violated
   // condition, then output it. Not all exceptions do (e.g., when
-  // creating an exception inside DEAL_II_NOT_IMPLEMENTED()), so
+  // creating an exception inside DEAL_II_NOT_IMPLEMENTED();), so
   // we have to check whether there is anything to print.
   if (cond != nullptr)
     out << "The violated condition was: " << std::endl
index 0814474acb34843d3b39599d5967ff864631af7b..45e1582ba78a3a3dcb435a202e70f7ec6c10a7ce 100644 (file)
@@ -180,7 +180,7 @@ namespace Functions
   std::size_t
   FlowFunction<dim>::memory_consumption() const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return 0;
   }
 
@@ -343,7 +343,7 @@ namespace Functions
           }
         else
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -409,7 +409,7 @@ namespace Functions
           }
         else
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -480,7 +480,7 @@ namespace Functions
           }
         else
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
index 9d467051d93f16736a7d7cf02e57f34043bde002..c2e2ed63ce290979a124175f31a171c10201e6a8 100644 (file)
@@ -111,7 +111,7 @@ FunctionDerivative<dim>::value(const Point<dim>  &p,
                 f.value(p - 2 * incr[0], component)) /
                (12 * h);
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return 0.;
 }
@@ -154,7 +154,7 @@ FunctionDerivative<dim>::vector_value(const Point<dim> &p,
         result /= (12. * h);
         return;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -220,7 +220,7 @@ FunctionDerivative<dim>::value_list(const std::vector<Point<dim>> &points,
           values[i] = (values[i] - 8. * aux[i]) / (12 * h);
         return;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
index 31e5c4d0926ace227748bb6089f59e1db1687846..ffc8d1030efb9d07bafb5467a213a8c5f244c050 100644 (file)
@@ -270,7 +270,7 @@ namespace Functions
           return (1. - p[0] * p[0]) * (1. - p[1] * p[1]) * (1. - p[2] * p[2]) +
                  offset;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return 0.;
   }
@@ -301,7 +301,7 @@ namespace Functions
                 offset;
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -323,7 +323,7 @@ namespace Functions
                         (1. - p[1] * p[1]) * (1. - p[2] * p[2]) +
                         (1. - p[2] * p[2]) * (1. - p[0] * p[0]));
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return 0.;
   }
@@ -354,7 +354,7 @@ namespace Functions
                                  (1. - p[2] * p[2]) * (1. - p[0] * p[0]));
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -379,7 +379,7 @@ namespace Functions
           result[2] = -2. * p[2] * (1. - p[0] * p[0]) * (1. - p[1] * p[1]);
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return result;
   }
@@ -414,7 +414,7 @@ namespace Functions
                 -2. * p[2] * (1. - p[0] * p[0]) * (1. - p[1] * p[1]);
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -444,7 +444,7 @@ namespace Functions
                  std::cos(numbers::PI_2 * p[1]) *
                  std::cos(numbers::PI_2 * p[2]);
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return 0.;
   }
@@ -500,7 +500,7 @@ namespace Functions
                  std::cos(numbers::PI_2 * p[1]) *
                  std::cos(numbers::PI_2 * p[2]);
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return 0.;
   }
@@ -546,7 +546,7 @@ namespace Functions
                       std::sin(numbers::PI_2 * p[2]);
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return result;
   }
@@ -588,7 +588,7 @@ namespace Functions
                 std::cos(numbers::PI_2 * p[1]) * std::sin(numbers::PI_2 * p[2]);
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -642,7 +642,7 @@ namespace Functions
           }
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return result;
   }
@@ -704,7 +704,7 @@ namespace Functions
               }
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -737,7 +737,7 @@ namespace Functions
                   std::cos(numbers::PI_2 * p[d1]) *
                   std::cos(numbers::PI_2 * p[d2]));
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return 0.;
   }
@@ -772,7 +772,7 @@ namespace Functions
                       std::sin(numbers::PI_2 * p[2]);
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   }
 
@@ -807,7 +807,7 @@ namespace Functions
                           std::cos(numbers::PI_2 * p[d2]);
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -848,7 +848,7 @@ namespace Functions
                              std::sin(numbers::PI_2 * p[2]);
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -897,7 +897,7 @@ namespace Functions
                        std::sin(numbers::PI_2 * p[d2]);
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return result;
   }
@@ -944,7 +944,7 @@ namespace Functions
                            std::sin(numbers::PI_2 * p[d2]);
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -1006,7 +1006,7 @@ namespace Functions
               }
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -1027,7 +1027,7 @@ namespace Functions
         case 3:
           return std::exp(p[0]) * std::exp(p[1]) * std::exp(p[2]);
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return 0.;
   }
@@ -1056,7 +1056,7 @@ namespace Functions
               values[i] = std::exp(p[0]) * std::exp(p[1]) * std::exp(p[2]);
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -1074,7 +1074,7 @@ namespace Functions
         case 3:
           return 3 * std::exp(p[0]) * std::exp(p[1]) * std::exp(p[2]);
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return 0.;
   }
@@ -1103,7 +1103,7 @@ namespace Functions
               values[i] = 3 * std::exp(p[0]) * std::exp(p[1]) * std::exp(p[2]);
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -1128,7 +1128,7 @@ namespace Functions
           result[2] = result[0];
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return result;
   }
@@ -1161,7 +1161,7 @@ namespace Functions
               gradients[i][2] = gradients[i][0];
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -1443,7 +1443,7 @@ namespace Functions
   LSingularityGradFunction::gradient(const Point<2> & /*p*/,
                                      const unsigned int /*component*/) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return {};
   }
 
@@ -1454,7 +1454,7 @@ namespace Functions
     std::vector<Tensor<1, 2>> & /*gradients*/,
     const unsigned int /*component*/) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -1463,7 +1463,7 @@ namespace Functions
     const std::vector<Point<2>> & /*points*/,
     std::vector<std::vector<Tensor<1, 2>>> & /*gradients*/) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
   //--------------------------------------------------------------------
@@ -1813,7 +1813,7 @@ namespace Functions
           angle = std::atan2(direction[0], direction[1]);
           break;
         case 3:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     sine   = std::sin(angle);
     cosine = std::cos(angle);
index d0d7ee6177e8815dfda224da46fe930f97e8590d..d09a8f5d1ae656ca28588e210951b08852b9e3f2 100644 (file)
@@ -160,7 +160,7 @@ namespace Functions
       else if (dim == 2)
         return compute_signed_distance_ellipse(point);
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
       return 0.0;
     }
index e2f53917f843007dfd68932c1a3c43fb83999d73..bf2f4ab2200d1543b481614d93d4348debdb9a5d 100644 (file)
@@ -184,7 +184,7 @@ namespace Functions
                            const unsigned int /*component*/) const
 
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return {};
   }
 
@@ -239,7 +239,7 @@ namespace Functions
   Spherical<dim>::hessian(const Point<dim> & /*p*/,
                           const unsigned int /*component*/) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return {};
   }
 
index 0360b7d7c47937e682f78141d19dcbb9ebef20ec..e474dba95c55baf6c34041013ea8dd6db2e3c189 100644 (file)
@@ -102,7 +102,7 @@ namespace GeometricUtilities
               break;
             }
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             break;
         }
 
index 6d523ebd32610752dc31e7ad82332560fa4adb81..f17d3af78b89fb28e81457f0b838582559c74536 100644 (file)
@@ -1370,7 +1370,7 @@ ParameterHandler::print_parameters(std::ostream     &out,
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
   // dive recursively into the subsections
@@ -1682,7 +1682,7 @@ ParameterHandler::recursively_print_parameters(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -1740,7 +1740,7 @@ ParameterHandler::recursively_print_parameters(
           }
         else
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
           }
 
         // then the contents of the subsection
@@ -1780,7 +1780,7 @@ ParameterHandler::recursively_print_parameters(
           }
         else
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
           }
       }
 }
index d4787dc1cff098a6613314ef9612e3e86a37d133..b8723fff5e2e003619bf9f708ae7daff9af61299 100644 (file)
@@ -97,7 +97,7 @@ namespace Patterns
               return u;
             }
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       return "";
     }
@@ -179,7 +179,7 @@ namespace Patterns
     if (p != nullptr)
       return p;
 
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
     return p;
   }
index 5906df4516e9d1a55a7bb4020d74cff528aceabd..7ccc4de85d87b177002cef232f56b745b25e9f32 100644 (file)
@@ -173,7 +173,7 @@ PolynomialsABF<dim>::n_polynomials(const unsigned int k)
         return 3 * (k + 3) * (k + 1) * (k + 1);
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return 0;
index 7c6c08650738b1f82a0d28ada7e1b0a624b4ff42..234e12ccfab21ff45b1032405306117ac9545445 100644 (file)
@@ -144,7 +144,7 @@ BarycentricPolynomials<dim>::get_fe_p_basis(const unsigned int degree)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return BarycentricPolynomials<dim>(polys);
index 6a2ec18212dd2664c2b9a53130446d345e9078a4..4a96cc13ec63144775466f34c5b171b02c934454 100644 (file)
@@ -45,7 +45,7 @@ PolynomialsBDM<dim>::PolynomialsBDM(const unsigned int k)
           monomials[i] = Polynomials::Monomial<double>(i);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -367,7 +367,7 @@ PolynomialsBDM<dim>::n_polynomials(const unsigned int k)
     return (k + 1) * (k + 2) + 2;
   if (dim == 3)
     return ((k + 1) * (k + 2) * (k + 3)) / 2 + 3 * (k + 1);
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index bed7318c2687fe11d2541a7490d59fd21e0fb7ea..64d7261590240aec369960cdd7f763c0e7a8b476 100644 (file)
@@ -244,7 +244,7 @@ PolynomialsBernardiRaugel<dim>::n_polynomials(const unsigned int k)
            GeometryInfo<dim>::faces_per_cell;
   // 2*4+4=12 polynomials in 2d and 3*8+6=30 polynomials in 3d
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index d5a824921b23b827c8aec61729fe17df05a41657..5bc28ad03bf16992a7efc7cc95b206cec0d0f963 100644 (file)
@@ -1474,7 +1474,7 @@ PolynomialsNedelec<dim>::evaluate(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1496,7 +1496,7 @@ PolynomialsNedelec<dim>::n_polynomials(const unsigned int k)
 
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return 0;
         }
     }
index f9a6403346960d0910103ffdeb4a4136f31934c7..fba27ffcd51b2c878a229396ed941063ff82ec7f 100644 (file)
@@ -31,7 +31,7 @@ namespace
           return 5;
       }
 
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
     return 0;
   }
@@ -153,7 +153,7 @@ ScalarLagrangePolynomialPyramid<dim>::compute_grad(const unsigned int i,
         }
       else
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -171,7 +171,7 @@ ScalarLagrangePolynomialPyramid<dim>::compute_grad_grad(
   (void)i;
   (void)p;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return Tensor<2, dim>();
 }
 
@@ -223,7 +223,7 @@ ScalarLagrangePolynomialPyramid<dim>::compute_2nd_derivative(
   (void)i;
   (void)p;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return {};
 }
@@ -239,7 +239,7 @@ ScalarLagrangePolynomialPyramid<dim>::compute_3rd_derivative(
   (void)i;
   (void)p;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return {};
 }
@@ -255,7 +255,7 @@ ScalarLagrangePolynomialPyramid<dim>::compute_4th_derivative(
   (void)i;
   (void)p;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return {};
 }
index 860732821a5427be6a3d42df87bec2002c20e598..262f303db044e6c0aef495cbc5a0425aafb54215 100644 (file)
@@ -58,7 +58,7 @@ PolynomialsRannacherTurek<dim>::compute_value(const unsigned int i,
               1.5 * (p[0] * p[0] - p[1] * p[1]));
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
@@ -94,7 +94,7 @@ PolynomialsRannacherTurek<dim>::compute_grad(const unsigned int i,
         }
       else
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
 
       return grad;
@@ -102,7 +102,7 @@ PolynomialsRannacherTurek<dim>::compute_grad(const unsigned int i,
 
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 }
@@ -151,7 +151,7 @@ PolynomialsRannacherTurek<dim>::compute_grad_grad(
 
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 }
index 3d27437bec31afa378e16bc37444aca732f42838..066a58005b1785e9c7919a8c467c2ed2587cfb5f 100644 (file)
@@ -844,7 +844,7 @@ PolynomialsRT_Bubbles<dim>::n_polynomials(const unsigned int k)
   if (dim == 1 || dim == 2 || dim == 3)
     return dim * Utilities::fixed_power<dim>(k + 1);
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index df88adc6863086ac494d6d6d841b246ae5b30231..4212ac2ddeccadd1e629afabf1eb7d1029886319 100644 (file)
@@ -32,7 +32,7 @@ namespace
           return 18;
       }
 
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
     return 0;
   }
@@ -103,7 +103,7 @@ ScalarLagrangePolynomialWedge<dim>::compute_grad_grad(const unsigned int i,
   (void)i;
   (void)p;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return Tensor<2, dim>();
 }
 
@@ -155,7 +155,7 @@ ScalarLagrangePolynomialWedge<dim>::compute_2nd_derivative(
   (void)i;
   (void)p;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return {};
 }
@@ -171,7 +171,7 @@ ScalarLagrangePolynomialWedge<dim>::compute_3rd_derivative(
   (void)i;
   (void)p;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return {};
 }
@@ -187,7 +187,7 @@ ScalarLagrangePolynomialWedge<dim>::compute_4th_derivative(
   (void)i;
   (void)p;
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return {};
 }
index d09401f0f628f02eb5a3e52ae2707c4216d24d5c..5dffef9157dfa19370c113ef331b85b4b69c31a1 100644 (file)
@@ -485,7 +485,7 @@ template <>
 QIterated<0>::QIterated(const Quadrature<1> &, const std::vector<Point<1>> &)
   : Quadrature<0>()
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -494,7 +494,7 @@ template <>
 QIterated<0>::QIterated(const Quadrature<1> &, const unsigned int)
   : Quadrature<0>()
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index 8e640c346373c9b7c7df10fc1b450583fa457535..4b56f42f12885c3d28eade8313d62878d18af1ce 100644 (file)
@@ -217,7 +217,7 @@ namespace internal
             q_points[7] = 0.977520613561287499;
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             break;
         }
       return q_points;
@@ -624,7 +624,7 @@ QGaussLog<1>::get_quadrature_points(const unsigned int n)
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         break;
     }
 
@@ -756,7 +756,7 @@ QGaussLog<1>::get_quadrature_weights(const unsigned int n)
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         break;
     }
 
@@ -1903,7 +1903,7 @@ QWitherdenVincentSimplex<dim>::QWitherdenVincentSimplex(
                 }
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         break;
       case 2:
@@ -2160,7 +2160,7 @@ QWitherdenVincentSimplex<dim>::QWitherdenVincentSimplex(
                 }
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         break;
       case 6:
@@ -2251,7 +2251,7 @@ QWitherdenVincentSimplex<dim>::QWitherdenVincentSimplex(
           }
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   Assert(b_point_permutations.size() == b_weights.size(), ExcInternalError());
@@ -2342,7 +2342,7 @@ QIteratedSimplex<dim>::QIteratedSimplex(const Quadrature<dim> &base_quad,
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
index 8fe926612c5c7d23bcef42c923d04439aac71bbd..e66629fb40fd184b5e7a0fba278ebc78fab48b6f 100644 (file)
@@ -38,7 +38,7 @@ template <int dim>
 std::size_t
 ScalarPolynomialsBase<dim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index d5ebf5649082756c045ed3647de35056d567f2c9..08b80f3a9ed531a3bcc9b06d5b5edc8859d56672 100644 (file)
@@ -42,7 +42,7 @@ namespace internal
                          const unsigned int,
                          std::array<unsigned int, dim> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
     inline void
index 84209e299028a094368ceaff9a60126bf7e18ed3..65cfe522d59a9a6e156bd163e550c19f2c063562 100644 (file)
@@ -99,7 +99,7 @@ double
 TensorProductPolynomialsBubbles<0>::compute_value(const unsigned int,
                                                   const Point<0> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0.;
 }
 
index 838fade87f8ba5767fec2df07dd77a86fe45bea0..f4b09cf004eb5adb0678df975c87957cf9fdc9bd 100644 (file)
@@ -87,7 +87,7 @@ double
 TensorProductPolynomialsConst<0>::compute_value(const unsigned int,
                                                 const Point<0> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0.;
 }
 
index 5fc03b0ceee6fd54fc81734cd7791a62b5bba20a..4e4fac745449c935251010eb3e568b758f2ed6de 100644 (file)
@@ -522,7 +522,7 @@ TimerOutput::get_summary_data(const OutputData kind) const
             output[section.first] = section.second.n_calls;
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
   return output;
index b2aa36ad779185c39fe0b9a47387ffdfbd5cd1fc..d6b436ab70fe4ea58b3ed35c2612e5efa3317c4f 100644 (file)
@@ -876,7 +876,7 @@ namespace Utilities
           return std::make_pair(i, 7U);
         else
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return std::make_pair(-1, numbers::invalid_unsigned_int);
           }
       }
index a75999eaf1a8c8311b4a180a8488b5af827b0ab5..e1a633abd48d74dc0a4cac15ebffbf5e88d28d0c 100644 (file)
@@ -811,7 +811,7 @@ namespace CGALWrappers
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return {};
       }
     (void)tol;
index 81d0c3a99a51a015255143102628f5a11cbe652c..1087fb397c290335c0618c7d28139cd658a53789 100644 (file)
@@ -351,7 +351,7 @@ namespace parallel
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
     void Triangulation<dim, spacedim>::execute_coarsening_and_refinement()
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
index 2a7fb94068cedb4c56c59030bf02316b35251f8a..afa4da231203b69f5f0be2109dc20039330f5fdd 100644 (file)
@@ -628,7 +628,7 @@ namespace parallel
               break;
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
               break;
           }
       }
index 85b8d60005b30759181aa66ccf89b00a4f24e2ae..8a5b164469889a1ec7fb14b2592bb9a52bcf0cdb 100644 (file)
@@ -793,7 +793,7 @@ namespace internal
               P8EST_QUADRANT_INIT(&p4est_children[c]);
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
 
 
@@ -813,7 +813,7 @@ namespace internal
             P8EST_QUADRANT_INIT(&quad);
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       functions<dim>::quadrant_set_morton(&quad,
                                           /*level=*/0,
index 8156890ef9012644f8b97ac13a210cdf74da5b6d..0628617b782cf6ba693e0b14b87bfea4f10613ad 100644 (file)
@@ -494,7 +494,7 @@ namespace parallel
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
     bool Triangulation<dim, spacedim>::with_artificial_cells() const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return true;
     }
 
@@ -515,7 +515,7 @@ namespace parallel
     const std::vector<unsigned int>
       &Triangulation<dim, spacedim>::get_true_subdomain_ids_of_cells() const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return true_subdomain_ids_of_cells;
     }
 
@@ -527,7 +527,7 @@ namespace parallel
       &Triangulation<dim, spacedim>::get_true_level_subdomain_ids_of_cells(
         const unsigned int) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return true_level_subdomain_ids_of_cells;
     }
   } // namespace shared
index 7c6321bd1035a1508fa72f393727a42141f8089f..8834eff6ef1f7f58e2a24a348fc022bbd0f7bec6 100644 (file)
@@ -247,7 +247,7 @@ namespace
                     }
 
                   default:
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                 }
             }
           else
@@ -419,7 +419,7 @@ namespace
                 P8EST_QUADRANT_INIT(&p4est_child[c]);
                 break;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
 
 
@@ -487,7 +487,7 @@ namespace
                     P8EST_QUADRANT_INIT(&p4est_child[c]);
                     break;
                   default:
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                 }
 
 
@@ -1345,7 +1345,7 @@ namespace
                 P8EST_QUADRANT_INIT(&p4est_child[c]);
                 break;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         internal::p4est::functions<dim>::quadrant_childrenv(&p4est_cell,
                                                             p4est_child);
@@ -1635,7 +1635,7 @@ namespace
                 P8EST_QUADRANT_INIT(&p4est_child[c]);
                 break;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
 
         dealii::internal::p4est::functions<dim>::quadrant_childrenv(
@@ -1676,7 +1676,7 @@ namespace
                 P8EST_QUADRANT_INIT(&p4est_child[c]);
                 break;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
 
         dealii::internal::p4est::functions<dim>::quadrant_childrenv(
@@ -4133,7 +4133,7 @@ namespace parallel
           smooth_grid,
           false)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -4165,7 +4165,7 @@ namespace parallel
       compute_level_vertices_with_ghost_neighbors(
         const unsigned int /*level*/) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
 
       return std::map<unsigned int, std::set<dealii::types::subdomain_id>>();
     }
@@ -4177,7 +4177,7 @@ namespace parallel
     std::vector<bool> Triangulation<1, spacedim>::
       mark_locally_active_vertices_on_level(const unsigned int) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<bool>();
     }
 
@@ -4188,7 +4188,7 @@ namespace parallel
     unsigned int Triangulation<1, spacedim>::
       coarse_cell_id_to_coarse_cell_index(const types::coarse_cell_id) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return 0;
     }
 
@@ -4200,7 +4200,7 @@ namespace parallel
       Triangulation<1, spacedim>::coarse_cell_index_to_coarse_cell_id(
         const unsigned int) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return 0;
     }
 
@@ -4210,7 +4210,7 @@ namespace parallel
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>))
     void Triangulation<1, spacedim>::load(const std::string &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -4219,7 +4219,7 @@ namespace parallel
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>))
     void Triangulation<1, spacedim>::load(const std::string &, const bool)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -4228,7 +4228,7 @@ namespace parallel
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>))
     void Triangulation<1, spacedim>::save(const std::string &) const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -4237,7 +4237,7 @@ namespace parallel
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>))
     bool Triangulation<1, spacedim>::is_multilevel_hierarchy_constructed() const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return false;
     }
 
@@ -4247,7 +4247,7 @@ namespace parallel
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>))
     bool Triangulation<1, spacedim>::are_vertices_communicated_to_p4est() const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return false;
     }
 
@@ -4257,7 +4257,7 @@ namespace parallel
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>))
     void Triangulation<1, spacedim>::update_cell_relations()
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
   } // namespace distributed
index bd299bbe8a23c0a3c8255ab04970c948158f26e6..c98c8dd0544e50c7bffcbfdbd0d840db1ceecb17 100644 (file)
@@ -218,7 +218,7 @@ namespace internal
               break;
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
               max_couplings = 0;
           }
         return std::min(max_couplings, dof_handler.n_dofs());
@@ -249,7 +249,7 @@ namespace internal
             27 * dof_handler.fe_collection.max_dofs_per_hex();
         else
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             max_couplings = 0;
           }
 
@@ -2580,7 +2580,7 @@ unsigned int DoFHandler<dim, spacedim>::max_couplings_between_boundary_dofs()
                 28 * this->fe_collection.max_dofs_per_line() +
                 8 * this->fe_collection.max_dofs_per_quad());
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return 0;
     }
 }
index 30517176af3b7d894324113b6ad3a57058fd7706..bd08718336e8c86b1294ca5a17a3ad7515661abc 100644 (file)
@@ -125,7 +125,7 @@ namespace internal
                     }
 
                   default:
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                 }
 
 #ifdef DEBUG
@@ -3225,7 +3225,7 @@ namespace internal
       {
 #ifndef DEAL_II_WITH_MPI
         (void)new_numbers;
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return NumberCache();
 #else
         // Similar to distribute_dofs() we need to have a special treatment in
@@ -3386,7 +3386,7 @@ namespace internal
         const std::vector<types::global_dof_index> & /*new_numbers*/) const
       {
         // multigrid is not currently implemented for shared triangulations
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
         return {};
       }
@@ -3503,7 +3503,7 @@ namespace internal
         {
 #  ifndef DEAL_II_WITH_MPI
           (void)dof_handler;
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
 #  else
 
           // define functions that pack data on cells that are ghost cells
@@ -3605,7 +3605,7 @@ namespace internal
       ParallelDistributed<dim, spacedim>::distribute_dofs() const
       {
 #ifndef DEAL_II_WITH_MPI
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return NumberCache();
 #else
 
@@ -3813,7 +3813,7 @@ namespace internal
       ParallelDistributed<dim, spacedim>::distribute_mg_dofs() const
       {
 #ifndef DEAL_II_WITH_MPI
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return std::vector<NumberCache>();
 #else
 
@@ -3995,7 +3995,7 @@ namespace internal
                ExcInternalError());
 
 #ifndef DEAL_II_WITH_MPI
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return NumberCache();
 #else
 
@@ -4129,7 +4129,7 @@ namespace internal
         (void)level;
         (void)new_numbers;
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return NumberCache();
 #else
 
index e1ecc4f570d12b5692fc555e70a56896e9f6d306..c179014677ef20da40837205215f3ea04b9c25ae 100644 (file)
@@ -1406,7 +1406,7 @@ namespace DoFRenumbering
                                                   renumbering);
           }
 #else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 #endif
       }
     else
index 91911b6113568f740efd9822601ddbc235bf1d1e..03721c5b0a7751ecdff1f2e6e484f84cf503fcc9 100644 (file)
@@ -913,7 +913,7 @@ FiniteElement<dim, spacedim>::interface_constraints_size() const
                   4 * this->n_dofs_per_quad(face_no),
                 this->n_dofs_per_face(face_no)};
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return {numbers::invalid_unsigned_int, numbers::invalid_unsigned_int};
 }
@@ -976,7 +976,7 @@ std::vector<std::pair<unsigned int, unsigned int>>
 FiniteElement<dim, spacedim>::hp_vertex_dof_identities(
   const FiniteElement<dim, spacedim> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return std::vector<std::pair<unsigned int, unsigned int>>();
 }
 
@@ -987,7 +987,7 @@ std::vector<std::pair<unsigned int, unsigned int>>
 FiniteElement<dim, spacedim>::hp_line_dof_identities(
   const FiniteElement<dim, spacedim> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return std::vector<std::pair<unsigned int, unsigned int>>();
 }
 
@@ -999,7 +999,7 @@ FiniteElement<dim, spacedim>::hp_quad_dof_identities(
   const FiniteElement<dim, spacedim> &,
   const unsigned int) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return std::vector<std::pair<unsigned int, unsigned int>>();
 }
 
@@ -1011,7 +1011,7 @@ FiniteElement<dim, spacedim>::compare_for_domination(
   const FiniteElement<dim, spacedim> &,
   const unsigned int) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -1212,7 +1212,7 @@ template <int dim, int spacedim>
 std::pair<Table<2, bool>, std::vector<unsigned int>>
 FiniteElement<dim, spacedim>::get_constant_modes() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return std::pair<Table<2, bool>, std::vector<unsigned int>>(
     Table<2, bool>(this->n_components(), this->n_dofs_per_cell()),
     std::vector<unsigned int>(this->n_components()));
@@ -1233,7 +1233,7 @@ FiniteElement<dim, spacedim>::
                     "the glossary for a definition of generalized support "
                     "points). Consequently, the current function can not "
                     "be defined and is not implemented by the element."));
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index ad330c574ecce2095c99f529a6270a74158b8922..45d31415cb90a3e2ad21071d9597e3d895add518 100644 (file)
@@ -645,7 +645,7 @@ template <int dim>
 std::size_t
 FE_ABF<dim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index 6da8fc15a5b0c25bff315e84f2cb9b3fb485e311..1d732a241087aab0547b5fe100e2c4eb70efdc41 100644 (file)
@@ -248,7 +248,7 @@ FE_Bernstein<dim, spacedim>::hp_vertex_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -327,7 +327,7 @@ FE_Bernstein<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index f8cdde42e1b4647e8afd2953d253ea536e51faac..3c57909b7b3fac21cd9e1af7dbb259d5403663e1 100644 (file)
@@ -174,7 +174,7 @@ FE_DGP<dim, spacedim>::hp_vertex_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -191,7 +191,7 @@ FE_DGP<dim, spacedim>::hp_line_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -209,7 +209,7 @@ FE_DGP<dim, spacedim>::hp_quad_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -256,7 +256,7 @@ FE_DGP<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -289,7 +289,7 @@ template <int dim, int spacedim>
 std::size_t
 FE_DGP<dim, spacedim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index 66fd1f57768660abb140ab511bfab7c3ad8418ea..2efdb1e805795efe543bb24293f6239bfe4e7210 100644 (file)
@@ -252,7 +252,7 @@ template <int dim>
 void
 FE_DGPMonomial<dim>::initialize_restriction()
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -351,7 +351,7 @@ FE_DGPMonomial<dim>::hp_vertex_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -369,7 +369,7 @@ FE_DGPMonomial<dim>::hp_line_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -387,7 +387,7 @@ FE_DGPMonomial<dim>::hp_quad_dof_identities(const FiniteElement<dim> &fe_other,
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -433,7 +433,7 @@ FE_DGPMonomial<dim>::compare_for_domination(const FiniteElement<dim> &fe_other,
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -504,7 +504,7 @@ template <int dim>
 std::size_t
 FE_DGPMonomial<dim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index 2e391ff17855b7b306df4e3fd1112100ffac0970..4debab778584ff185c10575dda494ef607e1e521 100644 (file)
@@ -545,7 +545,7 @@ FE_DGPNonparametric<dim, spacedim>::hp_vertex_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -564,7 +564,7 @@ FE_DGPNonparametric<dim, spacedim>::hp_line_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -584,7 +584,7 @@ FE_DGPNonparametric<dim, spacedim>::hp_quad_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -631,7 +631,7 @@ FE_DGPNonparametric<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -652,7 +652,7 @@ template <int dim, int spacedim>
 std::size_t
 FE_DGPNonparametric<dim, spacedim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index f1d15b8667db4a5843489daae1f50b131d1e0249..0a47a1b0ef070dcf7fd261ad139cc77d2d69d5c6 100644 (file)
@@ -261,7 +261,7 @@ FE_DGQ<dim, spacedim>::rotate_indices(std::vector<unsigned int> &numbers,
                   }
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -737,7 +737,7 @@ FE_DGQ<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -827,7 +827,7 @@ FE_DGQ<dim, spacedim>::has_support_on_face(const unsigned int shape_index,
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return true;
 }
index 9903b60a50ce0fa0cb3af48c02b3183fe51a464d..e9b8b0970876623dde856044fa75ccd61c5ef69c 100644 (file)
@@ -950,7 +950,7 @@ FE_Enriched<dim, spacedim>::hp_vertex_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -968,7 +968,7 @@ FE_Enriched<dim, spacedim>::hp_line_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -988,7 +988,7 @@ FE_Enriched<dim, spacedim>::hp_quad_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -1022,7 +1022,7 @@ FE_Enriched<dim, spacedim>::compare_for_domination(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return FiniteElementDomination::neither_element_dominates;
     }
 }
index 96d40702664a3060407639df3c8be961ec34e025..79ea61a22e82e41a3182ca250b97cb393a973f46 100644 (file)
@@ -356,7 +356,7 @@ FE_FaceQ<dim, spacedim>::hp_line_dof_identities(
         }
       else
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return std::vector<std::pair<unsigned int, unsigned int>>();
         }
     }
@@ -435,7 +435,7 @@ FE_FaceQ<dim, spacedim>::hp_quad_dof_identities(
         }
       else
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return std::vector<std::pair<unsigned int, unsigned int>>();
         }
     }
@@ -476,7 +476,7 @@ FE_FaceQ<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -861,7 +861,7 @@ FE_FaceP<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index 1030b6fb5cba2f24a5749e26d84e67125e2edfcf..ef139d0f3a2a42329ac31cc9dbc8ab245f169a79 100644 (file)
@@ -584,12 +584,12 @@ FE_Hermite<dim, spacedim>::hp_vertex_dof_identities(
   else if (const FE_Hermite<dim, spacedim> *fe_herm_other =
              dynamic_cast<const FE_Hermite<dim, spacedim> *>(&fe_other))
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 }
@@ -733,7 +733,7 @@ FE_Hermite<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index 3e5db68626dc7bf77f5913cca8c0bd9386de8f74..156f12b72186c6be1d8e50799022aaef55a5279b 100644 (file)
@@ -203,7 +203,7 @@ FE_Nedelec<dim>::FE_Nedelec(const unsigned int order)
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   // We need to initialize the dof permutation table and the one for the sign
@@ -266,7 +266,7 @@ template <>
 void
 FE_Nedelec<1>::initialize_support_points(const unsigned int)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2049,7 +2049,7 @@ FE_Nedelec<dim>::initialize_restriction()
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -2139,7 +2139,7 @@ FE_Nedelec<dim>::has_support_on_face(const unsigned int shape_index,
 
             default:
               {
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
                 return false;
               }
           }
@@ -2318,14 +2318,14 @@ FE_Nedelec<dim>::has_support_on_face(const unsigned int shape_index,
 
             default:
               {
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
                 return false;
               }
           }
 
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return false;
         }
     }
@@ -2363,7 +2363,7 @@ FE_Nedelec<dim>::compare_for_domination(const FiniteElement<dim> &fe_other,
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -2420,7 +2420,7 @@ FE_Nedelec<dim>::hp_line_dof_identities(
 
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -2467,7 +2467,7 @@ FE_Nedelec<dim>::hp_quad_dof_identities(const FiniteElement<dim> &fe_other,
 
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -2565,7 +2565,7 @@ FE_Nedelec<1>::get_subface_interpolation_matrix(const FiniteElement<1, 1> &,
                                                 FullMatrix<double> &,
                                                 const unsigned int) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3021,7 +3021,7 @@ FE_Nedelec<dim>::get_subface_interpolation_matrix(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -4090,7 +4090,7 @@ FE_Nedelec<dim>::convert_generalized_support_point_values_to_dof_values(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -4116,7 +4116,7 @@ template <int dim>
 std::size_t
 FE_Nedelec<dim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
@@ -4173,7 +4173,7 @@ FE_Nedelec<dim>::get_embedding_dofs(const unsigned int sub_degree) const
           return embedding_dofs;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return std::vector<unsigned int>();
     }
 }
index 134107d4d0b6914052528d60b050adf466251bd7..23dfb9ef0a3d3b4c6b6075b1cdc35826ab1e2eb9 100644 (file)
@@ -142,7 +142,7 @@ FE_NedelecSZ<dim, spacedim>::FE_NedelecSZ(const unsigned int order)
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -168,7 +168,7 @@ FE_NedelecSZ<dim, spacedim>::shape_value_component(
   const unsigned int /*component*/) const
 {
   // Not implemented yet:
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0.;
 }
 
@@ -192,7 +192,7 @@ FE_NedelecSZ<dim, spacedim>::shape_grad_component(
   const Point<dim> & /*p*/,
   const unsigned int /*component*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return Tensor<1, dim>();
 }
 
@@ -216,7 +216,7 @@ FE_NedelecSZ<dim, spacedim>::shape_grad_grad_component(
   const Point<dim> & /*p*/,
   const unsigned int /*component*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return Tensor<2, dim>();
 }
 
@@ -1558,7 +1558,7 @@ FE_NedelecSZ<dim, spacedim>::get_data(
         }
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
   return data_ptr;
@@ -2257,7 +2257,7 @@ FE_NedelecSZ<dim, spacedim>::fill_edge_values(
         }
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -3305,7 +3305,7 @@ FE_NedelecSZ<dim, spacedim>::fill_fe_subface_values(
   dealii::internal::FEValuesImplementation::FiniteElementRelatedData<dim, dim>
     & /*data*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3399,7 +3399,7 @@ FE_NedelecSZ<dim, spacedim>::compute_num_dofs(const unsigned int degree) const
 
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return 0;
         }
     }
index 1b2b49a3a6ab7cdc04dfa5a9fbc6226e98b9bc91..661f2f6aae5d1fcd20f0afc5585549dca6ede648 100644 (file)
@@ -613,7 +613,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
@@ -756,7 +756,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
@@ -1030,7 +1030,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
@@ -1041,7 +1041,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_values(
             (mapping_kind == mapping_raviart_thomas) ||
             (mapping_kind == mapping_nedelec))))
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -1252,7 +1252,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_face_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
@@ -1420,7 +1420,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_face_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
@@ -1718,14 +1718,14 @@ FE_PolyTensor<dim, spacedim>::fill_fe_face_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
       // third derivatives are not implemented
       if (fe_data.update_each & update_3rd_derivatives)
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -1940,7 +1940,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_subface_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
@@ -2094,7 +2094,7 @@ FE_PolyTensor<dim, spacedim>::fill_fe_subface_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
@@ -2391,14 +2391,14 @@ FE_PolyTensor<dim, spacedim>::fill_fe_subface_values(
                 }
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
 
       // third derivatives are not implemented
       if (fe_data.update_each & update_3rd_derivatives)
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -2497,7 +2497,7 @@ FE_PolyTensor<dim, spacedim>::requires_update_flags(
 
           default:
             {
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
             }
         }
     }
index e010ad4ae3633c04e28b581a8016913418781972..1f6eb3f8c0f621b95fc7177bff44a909d2384526 100644 (file)
@@ -48,7 +48,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
     return dpo;
@@ -65,7 +65,7 @@ namespace
     if (degree == 1)
       n_dofs = 5;
     else
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
 
     return internal::expand(3, {{0, 0, 0, n_dofs}}, ReferenceCells::Pyramid);
   }
@@ -114,7 +114,7 @@ FE_PyramidPoly<dim, spacedim>::FE_PyramidPoly(
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -235,7 +235,7 @@ FE_PyramidP<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index 33c6c9e5b2ed9fd0cc9e5f910b89e09f16266410..f4b5563df3dde2766e9a4ad24d29b382cc1acfff 100644 (file)
@@ -268,7 +268,7 @@ FE_Q<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::neither_element_dominates;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index f5bfb1cc5ca3ee4a659c6217de939a9f80f06fcd..9d20b053bfb77ec15627a0c05640b769b1a3d7b2 100644 (file)
@@ -487,7 +487,7 @@ FE_Q_Base<dim, spacedim>::initialize(const std::vector<Point<1>> &points)
         tensor_const_poly_space_ptr->set_numbering(renumber);
         return;
       }
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }();
 
   // Finally fill in support points on cell and face and initialize
@@ -782,7 +782,7 @@ FE_Q_Base<dim, spacedim>::hp_vertex_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 }
@@ -877,7 +877,7 @@ FE_Q_Base<dim, spacedim>::hp_line_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 }
@@ -947,7 +947,7 @@ FE_Q_Base<dim, spacedim>::hp_quad_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -1658,7 +1658,7 @@ FE_Q_Base<dim, spacedim>::has_support_on_face(
           return false;
         }
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   else if (shape_index < this->get_first_hex_index())
     // dof is on a quad
@@ -1678,13 +1678,13 @@ FE_Q_Base<dim, spacedim>::has_support_on_face(
       if (dim == 3)
         return (quad_index == face_index);
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   else
     // dof on hex
     {
       // can only happen in 3d, but this case has already been covered above
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return false;
     }
 
index 3be49d131585fbe3006445ab11ea3c4c8c5d3e90..d8b30081f6e56986abe23a3e72f62b6ba3aa4fca 100644 (file)
@@ -545,7 +545,7 @@ FE_Q_Bubbles<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index 355ebbfab0da0dbd833b064def03f3702ea60369..0119d3a867fe97ced74235befd1f6a829681ebf1 100644 (file)
@@ -333,7 +333,7 @@ FE_Q_DG0<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index fb44b9e2bd5f89fb5801ced029b5a96dde9811b3..0d4e61f5f7e00b58acf89e6372dcb17586494009 100644 (file)
@@ -252,7 +252,7 @@ FE_Q_Hierarchical<dim>::hp_vertex_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -290,7 +290,7 @@ FE_Q_Hierarchical<dim>::hp_line_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -334,7 +334,7 @@ FE_Q_Hierarchical<dim>::hp_quad_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -381,7 +381,7 @@ FE_Q_Hierarchical<dim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -667,7 +667,7 @@ FE_Q_Hierarchical<dim>::initialize_constraints(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -806,7 +806,7 @@ FE_Q_Hierarchical<dim>::initialize_embedding_and_restriction(
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 }
 
@@ -2152,7 +2152,7 @@ FE_Q_Hierarchical<dim>::hierarchic_to_fe_q_hierarchical_numbering(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return h2l;
 }
@@ -2271,7 +2271,7 @@ FE_Q_Hierarchical<dim>::has_support_on_face(const unsigned int shape_index,
       if (dim == 3)
         return (quad_index == face_index);
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   else
     // dof on hex
@@ -2279,7 +2279,7 @@ FE_Q_Hierarchical<dim>::has_support_on_face(const unsigned int shape_index,
       // can only happen in 3d, but
       // this case has already been
       // covered above
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return false;
     }
 
@@ -2423,7 +2423,7 @@ FE_Q_Hierarchical<dim>::get_embedding_dofs(const unsigned int sub_degree) const
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<unsigned int>();
     }
 }
@@ -2451,7 +2451,7 @@ template <int dim>
 std::size_t
 FE_Q_Hierarchical<dim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index b8fa658733cc3848ec72b77c4e373d3d1114fe2e..e2d4e41f48bed4df5d7948c9eb232f56ae35dab0 100644 (file)
@@ -174,7 +174,7 @@ FE_Q_iso_Q1<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index 367385db5785e2791115b9b63fa80511b0aa3d3a..ca13f783eda161333fabb6fdfdb73c7a85d36972 100644 (file)
@@ -725,7 +725,7 @@ template <int dim>
 std::size_t
 FE_RaviartThomas<dim>::memory_consumption() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index 8c9fa73799ed33de872556e4dae33a1d7b6123ea..6234a61a4e8dd8e452821df4116a5b61c5ff543f 100644 (file)
@@ -314,7 +314,7 @@ FE_RaviartThomasNodal<dim>::hp_vertex_dof_identities(
     return std::vector<std::pair<unsigned int, unsigned int>>();
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -370,7 +370,7 @@ FE_RaviartThomasNodal<dim>::hp_line_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -416,7 +416,7 @@ FE_RaviartThomasNodal<dim>::hp_quad_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -455,7 +455,7 @@ FE_RaviartThomasNodal<dim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index 5613c5ea28c21680f3882fba1ddac37c1881baed..1c8c5a2631065ca0b177b4d45a4ee252028e2ef0 100644 (file)
@@ -237,7 +237,7 @@ FE_RT_Bubbles<dim>::initialize_support_points(const unsigned int deg)
                                                   ((d == 2) ? low : high));
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       for (unsigned int k = 0; k < quadrature->size(); ++k)
index 15c620fe48b616f0fd65d4418332758d7b5b02a9..025086847b2447c77cfa7cb620b6f587166f2141 100644 (file)
@@ -72,7 +72,7 @@ namespace
               case 3:
                 return {1, 2};
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         case 2:
           switch (degree)
@@ -84,7 +84,7 @@ namespace
               case 3:
                 return {1, 2, 1};
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         case 3:
           switch (degree)
@@ -96,11 +96,11 @@ namespace
               case 3:
                 return {1, 2, 1, 0};
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
       }
 
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return {};
   }
 
@@ -312,7 +312,7 @@ namespace
                   continuous_dpo[dim]};
           }
 
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return {};
       }
   }
@@ -709,7 +709,7 @@ FE_SimplexP<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
@@ -753,7 +753,7 @@ FE_SimplexP<dim, spacedim>::hp_vertex_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 }
@@ -857,7 +857,7 @@ FE_SimplexP<dim, spacedim>::hp_line_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 }
@@ -950,7 +950,7 @@ FE_SimplexDGP<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index 6a106b942d138325c51a7d91dac514766524398d..e41c4da49d568a159267ae5bff03c1957cde4ba8 100644 (file)
@@ -111,7 +111,7 @@ namespace FE_P_BubblesImplementation
             return points;
           }
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return points;
   }
index 587e4b272a30a495bb21ed65af831253f3c036ec..daf7479aafed7f9628dba330fb9edc85a55d3a96 100644 (file)
@@ -1718,7 +1718,7 @@ FESystem<dim, spacedim>::build_interface_constraints()
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
 
         // now that we gathered all information: use it to build the
@@ -2356,7 +2356,7 @@ FESystem<dim, spacedim>::hp_object_dof_identities(
                   base.hp_quad_dof_identities(base_other, face_no);
                 break;
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
 
           for (const auto &base_identity : base_identities)
@@ -2404,7 +2404,7 @@ FESystem<dim, spacedim>::hp_object_dof_identities(
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return std::vector<std::pair<unsigned int, unsigned int>>();
     }
 }
@@ -2484,7 +2484,7 @@ FESystem<dim, spacedim>::compare_for_domination(
       return domination;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index e42cd128c7dba13270b5a4530a74b5c4fce1d45c..b15e4e8c054cac719e6f67f1e985abe0c30d9912 100644 (file)
@@ -207,7 +207,7 @@ FE_TraceQ<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index 66e2742dbc5c9ee829a6b083052d060ceadb8fb6..67768b2926ec0898d2b6227faa9fff3a5cc6c428 100644 (file)
@@ -914,7 +914,7 @@ namespace FEValuesViews
                 if (shape_function_data[shape_function]
                       .is_nonzero_shape_function_component[d])
                   {
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
 
                     // the following implementation needs to be looked over -- I
                     // think it can't be right, because we are in a case where
@@ -1084,7 +1084,7 @@ namespace FEValuesViews
                 if (shape_function_data[shape_function]
                       .is_nonzero_shape_function_component[d])
                   {
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                   }
             }
         }
@@ -1154,7 +1154,7 @@ namespace FEValuesViews
                 if (shape_function_data[shape_function]
                       .is_nonzero_shape_function_component[d])
                   {
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                   }
             }
         }
index 21a7dfaadbbdb653e1e99c99d60eab5a17bf1887..75ecb3c1b27928bdc2f742c7ed32cc48aad480f0 100644 (file)
@@ -55,7 +55,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 
     return dpo;
@@ -74,7 +74,7 @@ namespace
     else if (degree == 2)
       n_dofs = 18;
     else
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
 
     return internal::expand(3, {{0, 0, 0, n_dofs}}, ReferenceCells::Wedge);
   }
@@ -256,7 +256,7 @@ FE_WedgeP<dim, spacedim>::compare_for_domination(
         return FiniteElementDomination::no_requirements;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return FiniteElementDomination::neither_element_dominates;
 }
 
index d3f4bd5cc6642933a0c3c1b77555b689f5586a78..2c52b5e6a72dc5483fa667d13b6c764818d69078 100644 (file)
@@ -160,7 +160,7 @@ MappingC1<dim, spacedim>::add_line_support_points(
   const typename Triangulation<dim>::cell_iterator &,
   std::vector<Point<dim>> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -195,7 +195,7 @@ MappingC1<dim, spacedim>::add_quad_support_points(
   const typename Triangulation<dim>::cell_iterator &,
   std::vector<Point<dim>> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index 62f3064c54b05023e90be72daca5bfb11b2fca4d..fb0573de15f0a8d98d64aa27279813c4512379aa 100644 (file)
@@ -255,7 +255,7 @@ MappingCartesian<dim, spacedim>::update_cell_extents(
             data.cell_extents[2] = cell->vertex(4)[2] - start[2];
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -811,7 +811,7 @@ MappingCartesian<dim, spacedim>::transform(
           return;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -921,7 +921,7 @@ MappingCartesian<dim, spacedim>::transform(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1031,7 +1031,7 @@ MappingCartesian<dim, spacedim>::transform(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1070,7 +1070,7 @@ MappingCartesian<dim, spacedim>::transform(
           return;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1158,7 +1158,7 @@ MappingCartesian<dim, spacedim>::transform(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1189,7 +1189,7 @@ MappingCartesian<dim, spacedim>::transform_unit_to_real_cell(
         length[2] = cell->vertex(4)[2] - start[2];
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   Point<dim> p_real = cell->vertex(0);
@@ -1210,7 +1210,7 @@ MappingCartesian<dim, spacedim>::transform_real_to_unit_cell(
   Assert(is_cartesian(cell), ExcCellNotCartesian());
 
   if (dim != spacedim)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   const Point<dim> &start = cell->vertex(0);
   Point<dim>        real  = p;
   real -= start;
@@ -1230,7 +1230,7 @@ MappingCartesian<dim, spacedim>::transform_real_to_unit_cell(
         real[2] /= cell->vertex(4)[2] - start[2];
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return real;
 }
index 916d14e19b9b515b6d41e088a9e0b72d7666f401..c2f87a64223977f8e167a5b9028b1ccfa3447e5a 100644 (file)
@@ -1420,7 +1420,7 @@ namespace internal
                               cross_product_3d(data.aux[0][i], data.aux[1][i]);
                             break;
                           default:
-                            Assert(false, ExcNotImplemented());
+                            DEAL_II_NOT_IMPLEMENTED();
                         }
                   }
                 else //(dim < spacedim)
@@ -1478,7 +1478,7 @@ namespace internal
                           cell->subface_case(face_no), subface_no);
                        output_data.JxW_values[i] *= area_ratio;
 #else
-                      Assert(false, ExcNotImplemented());
+                      DEAL_II_NOT_IMPLEMENTED();
 #endif
                     }
                 }
@@ -1763,7 +1763,7 @@ namespace internal
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
 
@@ -1865,7 +1865,7 @@ namespace internal
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
 
@@ -2035,7 +2035,7 @@ namespace internal
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
 
@@ -2075,7 +2075,7 @@ namespace internal
                 return;
               }
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
     } // namespace
@@ -2142,7 +2142,7 @@ MappingFE<dim, spacedim>::transform(
                                                                output);
         return;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -2191,7 +2191,7 @@ MappingFE<dim, spacedim>::transform(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -2216,7 +2216,7 @@ MappingFE<dim, spacedim>::transform(
                                                               output);
         return;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
index 8830248f91eb91c1d1af7dba2dba25200eb411f0..2cac29eaa324152e7f915f435a18d9956199f07d 100644 (file)
@@ -74,7 +74,7 @@ std::size_t
 MappingFEField<dim, spacedim, VectorType>::InternalData::memory_consumption()
   const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
@@ -412,7 +412,7 @@ MappingFEField<dim, spacedim, VectorType>::get_vertices(
             for (const unsigned int v : cell->vertex_indices())
               vertices[v][comp] += fe_values.shape_value(i, v) * value;
           else
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
 
@@ -1314,7 +1314,7 @@ namespace internal
                           cross_product_3d(data.aux[0][i], data.aux[1][i]);
                         break;
                       default:
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
                     }
               }
             else //(dim < spacedim)
@@ -2016,7 +2016,7 @@ namespace internal
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
 
@@ -2055,7 +2055,7 @@ namespace internal
                 return;
               }
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
     } // namespace
@@ -2162,7 +2162,7 @@ MappingFEField<dim, spacedim, VectorType>::transform(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
index a1f7f132be4a45a645f4da4466162af06ccf95af..09b6973659e4697c2c31f0a962e36a5d2722b6d5 100644 (file)
@@ -161,7 +161,7 @@ MappingManifold<dim, spacedim>::transform_real_to_unit_cell(
   const typename Triangulation<dim, spacedim>::cell_iterator &,
   const Point<spacedim> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -685,7 +685,7 @@ namespace internal
                           cross_product_3d(data.aux[0][i], data.aux[1][i]);
                         break;
                       default:
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
                     }
               }
             else //(dim < spacedim)
@@ -732,7 +732,7 @@ namespace internal
                           }
 
                         default:
-                          Assert(false, ExcNotImplemented());
+                          DEAL_II_NOT_IMPLEMENTED();
                       }
                   }
               }
@@ -886,7 +886,7 @@ namespace internal
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
 
@@ -987,7 +987,7 @@ namespace internal
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
 
@@ -1156,7 +1156,7 @@ namespace internal
               }
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
 
@@ -1195,7 +1195,7 @@ namespace internal
                 return;
               }
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
       }
     } // namespace
@@ -1331,7 +1331,7 @@ MappingManifold<dim, spacedim>::transform(
           input, mapping_kind, mapping_data, output);
         return;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1380,7 +1380,7 @@ MappingManifold<dim, spacedim>::transform(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1403,7 +1403,7 @@ MappingManifold<dim, spacedim>::transform(
           input, mapping_kind, mapping_data, output);
         return;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
index 943098bd8049bce802e8958a735d343b2013b443..fd4ab49ce59c4d12e3e54dba2de4e0e6c20f2ce4 100644 (file)
@@ -462,7 +462,7 @@ MappingQ<1, 3>::transform_real_to_unit_cell_internal(
   const Point<3> &,
   const Point<1> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -1370,7 +1370,7 @@ MappingQ<dim, spacedim>::transform(
                                                               output);
         return;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1422,7 +1422,7 @@ MappingQ<dim, spacedim>::transform(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1447,7 +1447,7 @@ MappingQ<dim, spacedim>::transform(
                                                              output);
         return;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
@@ -1719,7 +1719,7 @@ MappingQ<dim, spacedim>::compute_mapping_support_points(
               break;
 
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
               break;
           }
     }
index 8bcc8b1f4c205eca1059f13d143ba0b50528d05a..eb1b64431aea9eaedbc15b12f9f5583377b14e2a 100644 (file)
@@ -1435,7 +1435,7 @@ namespace GridGenerator
           Assert(count == 48, ExcInternalError());
         }
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -1578,7 +1578,7 @@ namespace GridGenerator
 
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // Prepare cell data
@@ -1723,7 +1723,7 @@ namespace GridGenerator
           cells[3].material_id = 0;
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     tria.create_triangulation(points, cells, SubCellData());
   }
@@ -2148,7 +2148,7 @@ namespace GridGenerator
                 const Point<3> (& /*corners*/)[3],
                 const bool /*colorize*/)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
   template <>
@@ -2157,7 +2157,7 @@ namespace GridGenerator
                 const Point<1> (& /*corners*/)[1],
                 const bool /*colorize*/)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
   // Implementation for 2d only
@@ -2367,7 +2367,7 @@ namespace GridGenerator
           break;
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // Prepare cell data
@@ -2448,7 +2448,7 @@ namespace GridGenerator
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // Create triangulation
@@ -2557,7 +2557,7 @@ namespace GridGenerator
           break;
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // next create the cells
@@ -2620,7 +2620,7 @@ namespace GridGenerator
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     tria.create_triangulation(points, cells, SubCellData());
@@ -2773,7 +2773,7 @@ namespace GridGenerator
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // next create the cells
@@ -2841,7 +2841,7 @@ namespace GridGenerator
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     tria.create_triangulation(points, cells, SubCellData());
@@ -2926,7 +2926,7 @@ namespace GridGenerator
 
     // set boundary indicator
     if (colorize)
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3184,7 +3184,7 @@ namespace GridGenerator
           break;
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // next create the cells
@@ -3242,7 +3242,7 @@ namespace GridGenerator
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     tria.create_triangulation(points, cells, SubCellData());
@@ -3266,7 +3266,7 @@ namespace GridGenerator
                     const unsigned int /*n_slices*/,
                     const bool /*colorize*/)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3279,7 +3279,7 @@ namespace GridGenerator
                         const double /*skewness*/,
                         const bool /*colorize*/)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3904,7 +3904,7 @@ namespace GridGenerator
   void
   hyper_cube_slit(Triangulation<1> &, const double, const double, const bool)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3917,7 +3917,7 @@ namespace GridGenerator
                       const double,
                       const bool)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3926,7 +3926,7 @@ namespace GridGenerator
   void
   hyper_L(Triangulation<1> &, const double, const double, const bool)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3935,7 +3935,7 @@ namespace GridGenerator
   void
   hyper_ball(Triangulation<1> &, const Point<1> &, const double, const bool)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3944,7 +3944,7 @@ namespace GridGenerator
   void
   hyper_ball_balanced(Triangulation<1> &, const Point<1> &, const double)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3953,7 +3953,7 @@ namespace GridGenerator
   void
   cylinder(Triangulation<1> &, const double, const double)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3964,7 +3964,7 @@ namespace GridGenerator
                       const double,
                       const double)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3973,7 +3973,7 @@ namespace GridGenerator
   void
   truncated_cone(Triangulation<1> &, const double, const double, const double)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -3987,7 +3987,7 @@ namespace GridGenerator
               const unsigned int,
               const bool)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
   template <>
@@ -3999,7 +3999,7 @@ namespace GridGenerator
                  const unsigned int,
                  const unsigned int)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -4007,7 +4007,7 @@ namespace GridGenerator
   void
   quarter_hyper_ball(Triangulation<1> &, const Point<1> &, const double)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -4015,7 +4015,7 @@ namespace GridGenerator
   void
   half_hyper_ball(Triangulation<1> &, const Point<1> &, const double)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -4028,7 +4028,7 @@ namespace GridGenerator
                    const unsigned int,
                    const bool)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
   template <>
@@ -4040,7 +4040,7 @@ namespace GridGenerator
                       const unsigned int,
                       const bool)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
   template <>
@@ -4504,7 +4504,7 @@ namespace GridGenerator
                       const double,
                       const double)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -4519,7 +4519,7 @@ namespace GridGenerator
                  const unsigned int,
                  const unsigned int)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -5043,7 +5043,7 @@ namespace GridGenerator
 
     if (colorize)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
   }
 
@@ -7258,7 +7258,7 @@ namespace GridGenerator
                                    const unsigned int,
                                    const bool)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -8123,7 +8123,7 @@ namespace GridGenerator
             }
           else
             {
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
             }
         };
 
@@ -8173,7 +8173,7 @@ namespace GridGenerator
                        manifold_id_cell);
           }
         else
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
 
         // Set up sub-cell data.
         for (const auto f : cell->face_indices())
@@ -8202,7 +8202,7 @@ namespace GridGenerator
                   add_cell(1, edge_vertices, bid, mid);
               }
             else
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
 
         // set manifold ids of edges that were already present in the
index 9ad5359c3e6292f834fe0c7718662b9d596f37dd..c95815104b8f0f990504e1603698b6aaaf34433e 100644 (file)
@@ -269,7 +269,7 @@ namespace GridGenerator
                 const std::pair<Point<spacedim>, double> &,
                 const double)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
index 130fbf8ede308badbe53a209efe92e0444a64bf8..5540a823edee9621d3674615ab562f10c44fccae 100644 (file)
@@ -1769,7 +1769,7 @@ GridIn<dim, spacedim>::read_comsol_mphtxt(std::istream &in)
                 Assert(false, ExcInternalError());
             }
           else
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       // Then also read the "geometric entity indices". There need to
@@ -1828,7 +1828,7 @@ GridIn<dim, spacedim>::read_comsol_mphtxt(std::istream &in)
                     Assert(false, ExcInternalError());
                 }
               else
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
         }
     }
@@ -3391,7 +3391,7 @@ template <int dim, int spacedim>
 void
 GridIn<dim, spacedim>::read_tecplot(std::istream &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3600,7 +3600,7 @@ namespace
     else if (type_name_2 == "HEX" || type_name_2 == "HEXAHEDRON")
       return ReferenceCells::Hexahedron;
 
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return ReferenceCells::Invalid;
   }
 
@@ -3994,7 +3994,7 @@ GridIn<dim, spacedim>::debug_output_grid(
   const std::vector<Point<spacedim>> & /*vertices*/,
   std::ostream & /*out*/)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -4270,7 +4270,7 @@ GridIn<dim, spacedim>::default_suffix(const Format format)
       case tecplot:
         return ".dat";
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return ".unknown_format";
     }
 }
index b8476649dbb8552f12ea8336aff46ed8ee84657c..7de2bb91ae6c8d8989d69b637e3183156433ef6d 100644 (file)
@@ -583,7 +583,7 @@ GridOut::default_suffix(const OutputFormat output_format)
       case vtu:
         return ".vtu";
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return "";
     }
 }
@@ -758,21 +758,21 @@ template <>
 void
 GridOut::write_dx(const Triangulation<1> &, std::ostream &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 template <>
 void
 GridOut::write_dx(const Triangulation<1, 2> &, std::ostream &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 template <>
 void
 GridOut::write_dx(const Triangulation<1, 3> &, std::ostream &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1096,7 +1096,7 @@ GridOut::write_msh(const Triangulation<dim, spacedim> &tria,
           else if (cell->reference_cell() == ReferenceCells::get_simplex<dim>())
             out << cell->vertex_index(vertex) + 1 << ' ';
           else
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       out << '\n';
     }
@@ -1195,7 +1195,7 @@ GridOut::write_ucd(const Triangulation<dim, spacedim> &tria,
             out << "hex     ";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       // it follows a list of the
@@ -1245,7 +1245,7 @@ GridOut::write_xfig(const Triangulation<dim, spacedim> &,
                     std::ostream &,
                     const Mapping<dim, spacedim> *) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -2973,7 +2973,7 @@ void
 GridOut::write_mathgl(const Triangulation<1> &, std::ostream &) const
 {
   // 1d specialization not done yet
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -3032,7 +3032,7 @@ GridOut::write_mathgl(const Triangulation<dim, spacedim> &tria,
         out << "\nrotate 60 40";
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   out << '\n';
 
@@ -3056,7 +3056,7 @@ GridOut::write_mathgl(const Triangulation<dim, spacedim> &tria,
           << '\n';
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   // (iv) write a list of vertices of cells
@@ -3414,7 +3414,7 @@ GridOut::write_vtk(const Triangulation<dim, spacedim> &tria,
                 out << cell->vertex_index(permutation_table[i]);
               }
             else
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         out << '\n';
       }
@@ -4077,7 +4077,7 @@ GridOut::write_ucd_faces(const Triangulation<dim, spacedim> &tria,
               out << "quad    ";
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         // note: vertex numbers are 1-base
         for (unsigned int vertex = 0;
@@ -4482,7 +4482,7 @@ namespace internal
                   out << '\n'; // end of second line
                 }
               else
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             }
           else // need to handle curved boundaries
             {
@@ -4634,7 +4634,7 @@ namespace internal
               const GridOutFlags::Eps<2> &,
               const GridOutFlags::Eps<3> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
     void
@@ -4644,7 +4644,7 @@ namespace internal
               const GridOutFlags::Eps<2> &,
               const GridOutFlags::Eps<3> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
     void
@@ -4654,7 +4654,7 @@ namespace internal
               const GridOutFlags::Eps<2> &,
               const GridOutFlags::Eps<3> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
     void
@@ -4664,7 +4664,7 @@ namespace internal
               const GridOutFlags::Eps<2> &,
               const GridOutFlags::Eps<3> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
 
@@ -4906,7 +4906,7 @@ namespace internal
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
 
index eae7ca90e5831907600160deadeb2545982c5188..b91bd4d2f02ec8ead0ae6be75ab8fee3974ead2b 100644 (file)
@@ -436,7 +436,7 @@ GridRefinement::refine_and_coarsen_fixed_fraction(
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         break;
     }
 }
index b42d5a57d6359e9be0d2cf48fd63f085ef711b75..e9f675b212a2c9458b57049df0d38099d0dbc253 100644 (file)
@@ -304,7 +304,7 @@ namespace GridTools
                     const bool solve_for_absolute_positions)
   {
     if (dim == 1)
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
 
     // first provide everything that is needed for solving a Laplace
     // equation.
@@ -2200,7 +2200,7 @@ namespace GridTools
         const std::vector<CellId> &,
         std::vector<types::subdomain_id> &)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
     } // anonymous namespace
   }   // namespace internal
@@ -2219,7 +2219,7 @@ namespace GridTools
           const parallel::fullydistributed::Triangulation<dim, spacedim> *>(
           &triangulation) != nullptr)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
     else if (const parallel::distributed::Triangulation<dim, spacedim>
                *parallel_tria = dynamic_cast<
@@ -3128,7 +3128,7 @@ namespace GridTools
           }
         else
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
           }
 
         if (angle_fraction > limit_angle_fraction)
@@ -3221,7 +3221,7 @@ namespace GridTools
               }
             else
               {
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
               }
           }
       }
index a7a501d0db7bf6ea6a4966c68e7e9d3bbab45bee..3fc5b0d57f06e7610678fb6d1bf090a594772626 100644 (file)
@@ -518,7 +518,7 @@ namespace GridTools
     if (dim == 1)
       return 0;
     if (dim == 2 && spacedim == 3)
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
 
     std::size_t n_negative_cells = 0;
     std::size_t cell_no          = 0;
@@ -1378,7 +1378,7 @@ namespace GridTools
                                 throw ExcMeshNotOrientable();
                             }
                           else
-                            Assert(false, ExcNotImplemented());
+                            DEAL_II_NOT_IMPLEMENTED();
                         }
                     }
                 }
@@ -1472,7 +1472,7 @@ namespace GridTools
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       // now rotate raw_cells[cell_index] in such a way that its orientation
@@ -1536,7 +1536,7 @@ namespace GridTools
 
           default:
             {
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
             }
         }
     }
index 5a0e747b03474e32fd9689dbd119d53854acc9cf..d6f80ba591f04c3362e4bc3981f36304e1320fc7 100644 (file)
@@ -537,7 +537,7 @@ namespace internal
       // we get here from FlatManifold<2,3>::normal_vector, but
       // the implementation below is bogus for this case anyway
       // (see the assert at the beginning of that function).
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 
@@ -775,7 +775,7 @@ FlatManifold<1, 2>::get_normals_at_vertices(
   const Triangulation<1, 2>::face_iterator &,
   Manifold<1, 2>::FaceVertexNormals &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -786,7 +786,7 @@ FlatManifold<1, 3>::get_normals_at_vertices(
   const Triangulation<1, 3>::face_iterator &,
   Manifold<1, 3>::FaceVertexNormals &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -812,7 +812,7 @@ FlatManifold<2, 3>::get_normals_at_vertices(
   const Triangulation<2, 3>::face_iterator & /*face*/,
   Manifold<2, 3>::FaceVertexNormals & /*face_vertex_normals*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -850,7 +850,7 @@ Tensor<1, 1>
 FlatManifold<1, 1>::normal_vector(const Triangulation<1, 1>::face_iterator &,
                                   const Point<1> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -861,7 +861,7 @@ Tensor<1, 2>
 FlatManifold<1, 2>::normal_vector(const Triangulation<1, 2>::face_iterator &,
                                   const Point<2> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -872,7 +872,7 @@ Tensor<1, 3>
 FlatManifold<1, 3>::normal_vector(const Triangulation<1, 3>::face_iterator &,
                                   const Point<3> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
index 0a27044222298904c25209ed0518aa9ea1aa7497..bde0e13fbbb6ed0e878bc0a484ccc237b73b273a 100644 (file)
@@ -186,7 +186,7 @@ PolarManifold<dim, spacedim>::push_forward(
             break;
           }
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   return p + center;
 }
@@ -225,7 +225,7 @@ PolarManifold<dim, spacedim>::pull_back(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return p;
 }
@@ -273,7 +273,7 @@ PolarManifold<dim, spacedim>::push_forward_gradient(
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   return DX;
 }
@@ -618,7 +618,7 @@ namespace internal
         const ArrayView<const double> & /*weights*/,
         const Point<spacedim> & /*candidate_point*/)
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return {};
       }
 
@@ -1221,7 +1221,7 @@ template <int dim, int spacedim>
 Point<spacedim>
 EllipticalManifold<dim, spacedim>::push_forward(const Point<spacedim> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -1249,7 +1249,7 @@ template <int dim, int spacedim>
 Point<spacedim>
 EllipticalManifold<dim, spacedim>::pull_back(const Point<spacedim> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
@@ -1292,7 +1292,7 @@ DerivativeForm<1, spacedim, spacedim>
 EllipticalManifold<dim, spacedim>::push_forward_gradient(
   const Point<spacedim> &) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return {};
 }
 
index 00df4e62fbe21f09fdfa00a2ab4396ccff79c1cd..9e0e9c570acaf22f62bca02d4cf83948f1ad7b80 100644 (file)
@@ -109,7 +109,7 @@ ReferenceCell::to_string() const
       case ReferenceCells::Invalid:
         return "Invalid";
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return "Invalid";
@@ -136,7 +136,7 @@ ReferenceCell::get_default_mapping(const unsigned int degree) const
       FE_WedgeP<dim, spacedim>(degree));
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
   return std::make_unique<MappingQ<dim, spacedim>>(degree);
@@ -174,7 +174,7 @@ ReferenceCell::get_default_linear_mapping() const
     }
   else
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
     }
 
   return StaticMappingQ1<dim, spacedim>::mapping; // never reached
@@ -197,7 +197,7 @@ ReferenceCell::get_gauss_type_quadrature(const unsigned n_points_1d) const
   else if (*this == ReferenceCells::Wedge)
     return QGaussWedge<dim>(n_points_1d);
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   return Quadrature<dim>(); // never reached
 }
@@ -242,7 +242,7 @@ ReferenceCell::get_nodal_type_quadrature() const
       return quadrature;
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   static const Quadrature<dim> dummy;
   return dummy; // never reached
@@ -285,7 +285,7 @@ ReferenceCell::exodusii_vertex_to_deal_vertex(const unsigned int vertex_n) const
           return exodus_to_deal[vertex_n];
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -332,7 +332,7 @@ ReferenceCell::exodusii_face_to_deal_face(const unsigned int face_n) const
           return exodus_to_deal[face_n];
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -369,7 +369,7 @@ ReferenceCell::unv_vertex_to_deal_vertex(const unsigned int vertex_n) const
       return unv_to_deal[vertex_n];
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return numbers::invalid_unsigned_int;
 }
@@ -400,7 +400,7 @@ ReferenceCell::vtk_linear_type() const
       case ReferenceCells::Invalid:
         return VTKCellType::VTK_INVALID;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return VTKCellType::VTK_INVALID;
@@ -432,7 +432,7 @@ ReferenceCell::vtk_quadratic_type() const
       case ReferenceCells::Invalid:
         return VTKCellType::VTK_INVALID;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return VTKCellType::VTK_INVALID;
@@ -464,7 +464,7 @@ ReferenceCell::vtk_lagrange_type() const
       case ReferenceCells::Invalid:
         return VTKCellType::VTK_INVALID;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return VTKCellType::VTK_INVALID;
@@ -479,7 +479,7 @@ ReferenceCell::vtk_lexicographic_to_node_index<0>(
   const std::array<unsigned, 0> &,
   const bool) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
@@ -492,7 +492,7 @@ ReferenceCell::vtk_lexicographic_to_node_index<1>(
   const std::array<unsigned, 1> &,
   const bool) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
@@ -712,11 +712,11 @@ ReferenceCell::vtk_vertex_to_deal_vertex(const unsigned int vertex_index) const
         }
       case ReferenceCells::Invalid:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return numbers::invalid_unsigned_int;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -800,7 +800,7 @@ ReferenceCell::gmsh_element_type() const
         return 5;
       case ReferenceCells::Invalid:
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   return numbers::invalid_unsigned_int;
@@ -1115,7 +1115,7 @@ ReferenceCell::closest_point(const Point<dim> &p) const
             }
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
     }
   // We should be within 4 * eps of the cell by this point. The roundoff error
index 752e9b4ddddedbce5a253b9e1528056a409cf954..7ce15adee8a39ea0d4d67d6b7dc7313b9cdd6832 100644 (file)
@@ -6311,7 +6311,7 @@ namespace internal
                 }
               else
                 {
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
                 }
 
               for (const unsigned int line : quad->line_indices())
@@ -6482,7 +6482,7 @@ namespace internal
                        line_indices[quad_lines[i][2]],
                        line_indices[quad_lines[i][3]]});
                   else
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
 
                   new_quad->set_used_flag();
                   new_quad->clear_user_flag();
@@ -6593,7 +6593,7 @@ namespace internal
                     n_new_hexes = 8;
                   }
                 else
-                  Assert(false, ExcNotImplemented());
+                  DEAL_II_NOT_IMPLEMENTED();
 
                 std::array<raw_line_iterator, 6> new_lines;
                 for (unsigned int i = 0; i < n_new_lines; ++i)
@@ -6832,7 +6832,7 @@ namespace internal
                         AssertDimension(k, 13);
                       }
                     else
-                      Assert(false, ExcNotImplemented());
+                      DEAL_II_NOT_IMPLEMENTED();
 
                     boost::container::small_vector<unsigned int, 30>
                       relevant_line_indices(relevant_lines.size());
@@ -6928,7 +6928,7 @@ namespace internal
                              relevant_line_indices[new_quad_lines[q][2]],
                              relevant_line_indices[new_quad_lines[q][3]]});
                         else
-                          Assert(false, ExcNotImplemented());
+                          DEAL_II_NOT_IMPLEMENTED();
 
                         // On hexes, we must only determine a single line
                         // according to the representative_lines array above
@@ -7020,7 +7020,7 @@ namespace internal
                       }
                     else
                       {
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
                       }
 
                     static constexpr dealii::ndarray<unsigned int, 8, 6>
@@ -7155,7 +7155,7 @@ namespace internal
                              quad_indices[cell_quads[c][4]],
                              quad_indices[cell_quads[c][5]]});
                         else
-                          Assert(false, ExcNotImplemented());
+                          DEAL_II_NOT_IMPLEMENTED();
                       }
 
                     // for hexes, we can simply inherit the orientation values
@@ -12711,7 +12711,7 @@ void Triangulation<dim, spacedim>::create_triangulation(
               break;
             }
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
 
@@ -13233,7 +13233,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
   }
 } // namespace
@@ -13273,7 +13273,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
   }
 } // namespace
@@ -13313,7 +13313,7 @@ namespace
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
   }
 } // namespace
@@ -13352,7 +13352,7 @@ void Triangulation<dim, spacedim>::save_user_flags(std::ostream &out) const
     save_user_flags_hex(out);
 
   if (dim >= 4)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -13383,7 +13383,7 @@ void Triangulation<dim, spacedim>::save_user_flags(std::vector<bool> &v) const
     }
 
   if (dim >= 4)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -13401,7 +13401,7 @@ void Triangulation<dim, spacedim>::load_user_flags(std::istream &in)
     load_user_flags_hex(in);
 
   if (dim >= 4)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -13438,7 +13438,7 @@ void Triangulation<dim, spacedim>::load_user_flags(const std::vector<bool> &v)
     }
 
   if (dim >= 4)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -13735,7 +13735,7 @@ void Triangulation<dim, spacedim>::save_user_indices(
     }
 
   if (dim >= 4)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -13773,7 +13773,7 @@ void Triangulation<dim, spacedim>::load_user_indices(
     }
 
   if (dim >= 4)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 template <int dim, int spacedim>
@@ -14013,7 +14013,7 @@ void Triangulation<dim, spacedim>::save_user_pointers(
     }
 
   if (dim >= 4)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -14051,7 +14051,7 @@ void Triangulation<dim, spacedim>::load_user_pointers(
     }
 
   if (dim >= 4)
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -14174,7 +14174,7 @@ typename Triangulation<dim, spacedim>::raw_cell_iterator
       case 3:
         return begin_raw_hex(level);
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return raw_cell_iterator();
     }
 }
@@ -14216,7 +14216,7 @@ typename Triangulation<dim, spacedim>::active_cell_iterator
       case 3:
         return begin_active_hex(level);
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return active_cell_iterator();
     }
 }
@@ -14491,7 +14491,7 @@ typename Triangulation<dim, spacedim>::face_iterator
       case 3:
         return begin_quad();
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return face_iterator();
     }
 }
@@ -14513,7 +14513,7 @@ typename Triangulation<dim, spacedim>::active_face_iterator
       case 3:
         return begin_active_quad();
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return active_face_iterator();
     }
 }
@@ -14535,7 +14535,7 @@ typename Triangulation<dim, spacedim>::face_iterator
       case 3:
         return end_quad();
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return raw_face_iterator();
     }
 }
@@ -14742,7 +14742,7 @@ typename Triangulation<dim, spacedim>::raw_quad_iterator
 
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return raw_hex_iterator();
     }
 }
@@ -14840,7 +14840,7 @@ typename Triangulation<dim, spacedim>::raw_hex_iterator
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return raw_hex_iterator();
     }
 }
@@ -14992,7 +14992,7 @@ unsigned int Triangulation<dim, spacedim>::n_faces() const
       case 3:
         return n_quads();
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return 0;
 }
@@ -15011,7 +15011,7 @@ unsigned int Triangulation<dim, spacedim>::n_raw_faces() const
       case 3:
         return n_raw_quads();
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return 0;
 }
@@ -15030,7 +15030,7 @@ unsigned int Triangulation<dim, spacedim>::n_active_faces() const
       case 3:
         return n_active_quads();
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return 0;
 }
@@ -15050,7 +15050,7 @@ unsigned int Triangulation<dim, spacedim>::n_raw_cells(
       case 3:
         return n_raw_hexs(level);
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return 0;
 }
@@ -15071,7 +15071,7 @@ unsigned int Triangulation<dim, spacedim>::n_cells(
       case 3:
         return n_hexs(level);
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return 0;
 }
@@ -15092,7 +15092,7 @@ unsigned int Triangulation<dim, spacedim>::n_active_cells(
       case 3:
         return n_active_hexs(level);
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   return 0;
 }
@@ -15150,7 +15150,7 @@ unsigned int Triangulation<dim, spacedim>::n_raw_lines() const
 {
   if (dim == 1)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return 0;
     }
 
@@ -15388,7 +15388,7 @@ template <int dim, int spacedim>
 DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
 unsigned int Triangulation<dim, spacedim>::n_raw_quads() const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
index 4e6d80b33c5b2aa9e2b692769fc5de38d62e2e77..fc197f6877ee144f90077d9fe2806a904a77f2ee 100644 (file)
@@ -1279,7 +1279,7 @@ namespace
   {
     // this function catches all the cases not
     // explicitly handled above
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return {};
   }
 
@@ -1396,7 +1396,7 @@ namespace
         return 0.5 * cross_product_3d(v01, v02).norm();
       }
 
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return 0.0;
   }
 
@@ -1408,7 +1408,7 @@ namespace
   {
     // catch-all for all cases not explicitly
     // listed above
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return std::numeric_limits<double>::quiet_NaN();
   }
 
@@ -1568,7 +1568,7 @@ double
 TriaAccessor<structdim, dim, spacedim>::extent_in_direction(
   const unsigned int /*axis*/) const
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return std::numeric_limits<double>::signaling_NaN();
 }
 
@@ -1736,7 +1736,7 @@ bool
 TriaAccessor<0, 1, spacedim>::user_flag_set() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return true;
 }
 
@@ -1747,7 +1747,7 @@ void
 TriaAccessor<0, 1, spacedim>::set_user_flag() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1757,7 +1757,7 @@ void
 TriaAccessor<0, 1, spacedim>::clear_user_flag() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1793,7 +1793,7 @@ void
 TriaAccessor<0, 1, spacedim>::clear_user_data() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1803,7 +1803,7 @@ void
 TriaAccessor<0, 1, spacedim>::set_user_pointer(void *) const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1813,7 +1813,7 @@ void
 TriaAccessor<0, 1, spacedim>::clear_user_pointer() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1823,7 +1823,7 @@ void *
 TriaAccessor<0, 1, spacedim>::user_pointer() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return nullptr;
 }
 
@@ -1860,7 +1860,7 @@ void
 TriaAccessor<0, 1, spacedim>::set_user_index(const unsigned int) const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1870,7 +1870,7 @@ void
 TriaAccessor<0, 1, spacedim>::clear_user_index() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -1880,7 +1880,7 @@ unsigned int
 TriaAccessor<0, 1, spacedim>::user_index() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0;
 }
 
@@ -3109,7 +3109,7 @@ CellAccessor<dim, spacedim>::neighbor_child_on_subface(
             }
 
           // if no reference cell type matches
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return TriaIterator<CellAccessor<dim, spacedim>>();
         }
 
@@ -3459,13 +3459,13 @@ CellAccessor<dim, spacedim>::neighbor_child_on_subface(
             }
 
           // if no reference cell type matches
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return TriaIterator<CellAccessor<dim, spacedim>>();
         }
 
       default:
         // if 1d or more than 3d
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return TriaIterator<CellAccessor<dim, spacedim>>();
     }
 }
index 42fa69f7006aec3c0face5af021b7ad308210ceb..0ea8e560b39ed240434a1b2125b30b00a1eac7d0 100644 (file)
@@ -1808,7 +1808,7 @@ namespace CUDAWrappers
     LinearAlgebra::CUDAWrappers::Vector<Number> & /*dst*/,
     const LinearAlgebra::CUDAWrappers::Vector<Number> & /*src*/) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
index 89eaa6d7b17aa2b94a2fd57caadaa147e7028b8a..8cd65eeabc5a23638cb8e71a25d9604499365ac4 100644 (file)
@@ -524,7 +524,7 @@ namespace PETScWrappers
             string_type = "None";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       return string_type;
     }
index 857dc9b951ae49a1d65ea706c3c56f9847d21435..3f69e0bcb18e7dcab7b11fedb2dfcb8c0e2e92ae 100644 (file)
@@ -195,7 +195,7 @@ namespace PETScWrappers
           break;
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     PetscFunctionReturn(PETSC_SUCCESS);
index dfa8c1048937e6d880c032269ea74043264b4da3..2b34ebc2f75a92f4ddaf47c1d7a14c7412d4c1d8 100644 (file)
@@ -324,7 +324,7 @@ namespace SLEPcWrappers
           break;
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   }
 
index fc2c67c517d79046edeaa363490c46c1dbabcafe..7661bf5dffa35b20c8b46b2e24c38a418cafd371 100644 (file)
@@ -442,7 +442,7 @@ namespace TrilinosWrappers
           solver.SetAztecOption(AZ_solver, AZ_tfqmr);
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // Set the preconditioner
index bdfb9ca512a240f864eed13c45221d039fc05900..ef9cedaa836cfe04d2753dd08d9971e91a3741f6 100644 (file)
@@ -2247,7 +2247,7 @@ namespace TrilinosWrappers
   void
   SparseMatrix::write_ascii()
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
index 89aea89693bf8fcf486b3b8265734d2abd41732f..965bed9e81480d5d623d553fc136c155ec05decb 100644 (file)
@@ -637,7 +637,7 @@ namespace TrilinosWrappers
   SparsityPattern &
   SparsityPattern::operator=(const SparsityPattern &)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return *this;
   }
 
@@ -1003,7 +1003,7 @@ namespace TrilinosWrappers
   void
   SparsityPattern::write_ascii()
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -1072,7 +1072,7 @@ namespace TrilinosWrappers
   std::size_t
   SparsityPattern::memory_consumption() const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return 0;
   }
 
index fcde146be68d90462c50d8c9ac51e39b1e708d6b..dc533d7e668870c4772d7e13a8be7d489401fd0b 100644 (file)
@@ -656,7 +656,7 @@ namespace LinearAlgebra
     SparsityPattern<MemorySpace>::operator=(
       const SparsityPattern<MemorySpace> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return *this;
     }
 
@@ -833,7 +833,7 @@ namespace LinearAlgebra
 #  else
       (void)i;
       (void)j;
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return false;
 #  endif
     }
@@ -1070,7 +1070,7 @@ namespace LinearAlgebra
     std::size_t
     SparsityPattern<MemorySpace>::memory_consumption() const
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return 0;
     }
 
index cbe0ef2fcb28c9a29aa32df7cf6656064b126fcc..f315ce804e3ef07ce8626cb1e96e6c34e86e50cd 100644 (file)
@@ -112,7 +112,7 @@ namespace internal
               &fe_poly_ptr->get_poly_space()))
         return polyspace->get_underlying_polynomials();
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
   } // namespace FEPointEvaluation
index 064982f0490a9d1790465c87b3883d4d1a56f075..6d6151d10eef7277898ff5598f7c077104126d6c 100644 (file)
@@ -1049,7 +1049,7 @@ namespace internal
                       }
                     else
                       {
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
                       }
 
                     ++ki;
@@ -1159,7 +1159,7 @@ namespace internal
                   }
                 else
                   {
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                   }
 
                 if (++ki == ghost_indices_subset_data.second[ko].second)
index 3723b8ed698b6d7a3f92db63b45bd326daf2d540..5cd321d5c482fccb610940dbb68900047d255e5c 100644 (file)
@@ -59,7 +59,7 @@ namespace MGTools
                             std::vector<unsigned int> &,
                             const DoFTools::Coupling)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -72,7 +72,7 @@ namespace MGTools
                             const Table<2, DoFTools::Coupling> &,
                             const Table<2, DoFTools::Coupling> &)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -84,7 +84,7 @@ namespace MGTools
                             std::vector<unsigned int> &,
                             const DoFTools::Coupling)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
@@ -96,7 +96,7 @@ namespace MGTools
                             const Table<2, DoFTools::Coupling> &,
                             const Table<2, DoFTools::Coupling> &)
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
index 418e6943e32abb8f5523186a607cdb333db38c77..3627abd2c2c2cc0e644525b26d2baf3dbd644c9d 100644 (file)
@@ -865,7 +865,7 @@ DataOut<dim, spacedim>::build_one_patch(
                                   }
 
                                 default:
-                                  Assert(false, ExcNotImplemented());
+                                  DEAL_II_NOT_IMPLEMENTED();
                               }
                           }
                       }
@@ -948,7 +948,7 @@ DataOut<dim, spacedim>::build_one_patch(
                                   }
 
                                 default:
-                                  Assert(false, ExcNotImplemented());
+                                  DEAL_II_NOT_IMPLEMENTED();
                               }
                           }
                       }
index 05845bcedde7727e6a51f8347387fbf459aa5d84..f329c7212663e91d36b074d0f1d36c7d83ee77da 100644 (file)
@@ -115,7 +115,7 @@ DataOutRotation<dim, spacedim>::build_one_patch(
     {
       // would this function make any sense after all? who would want to
       // output/compute in four space dimensions?
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return;
     }
 
@@ -188,7 +188,7 @@ DataOutRotation<dim, spacedim>::build_one_patch(
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       // then fill in data
@@ -326,7 +326,7 @@ DataOutRotation<dim, spacedim>::build_one_patch(
                             break;
 
                           default:
-                            Assert(false, ExcNotImplemented());
+                            DEAL_II_NOT_IMPLEMENTED();
                         }
                     }
                 }
@@ -359,7 +359,7 @@ DataOutRotation<dim, spacedim>::build_one_patch(
                         break;
 
                       default:
-                        Assert(false, ExcNotImplemented());
+                        DEAL_II_NOT_IMPLEMENTED();
                     }
                 }
               else
@@ -400,7 +400,7 @@ DataOutRotation<dim, spacedim>::build_one_patch(
                             break;
 
                           default:
-                            Assert(false, ExcNotImplemented());
+                            DEAL_II_NOT_IMPLEMENTED();
                         }
                     }
                 }
@@ -444,7 +444,7 @@ DataOutRotation<dim, spacedim>::build_one_patch(
                     break;
 
                   default:
-                    Assert(false, ExcNotImplemented());
+                    DEAL_II_NOT_IMPLEMENTED();
                 }
             }
         }
index 3bccab903821c3e3e212917600b4509bc6deaa78..cce2a6e2d10926721bd01c42b9f68450f0cadd78 100644 (file)
@@ -370,7 +370,7 @@ DataOutStack<dim, spacedim>::build_patches(const unsigned int nnnn_subdivisions)
             break;
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
 
index befc737be4dcc505f6e6814db73f2e69914bbacf..dd51ea4d9cb6417093ac5d46c37fa605fef060ee 100644 (file)
@@ -503,7 +503,7 @@ namespace DerivativeApproximation
       // needs to be employed. maybe some
       // steps of the power method would
       // suffice?
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return 0;
     }
 
index 043e35ccdaf97f880fa93496ea7b92b943a66f21..8ed7226bc80362efe9e458f60aa12d3dfaa6888a 100644 (file)
@@ -220,7 +220,7 @@ namespace OpenCASCADE
                                  const ArrayView<const Point<spacedim>> &,
                                  const Point<spacedim> &)
     {
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
       return {};
     }
 
index 196748fbeeed1588e88112f8faf4f9d96bdfa606..9c6bab556b6fff24c8209ed16f59a6e061331332 100644 (file)
@@ -246,7 +246,7 @@ namespace Particles
             }
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
     return ranges;
index 86dedc21bf8cd60e0b147a72c9b29c81a0befb34..7d4300929c15958c74358c284aa90f70dfe5cfb4 100644 (file)
@@ -28,7 +28,7 @@ void
 check_tensor_product(const std::vector<Quadrature<dim>> &quadratures,
                      const std::vector<std::string>     &quadrature_names)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 template <>
index 284e573680ffbfbf2b9fee7dc17760d4a120270e..a294a30fc5c7b98180e8e5bb1429b9d186ef1be9 100644 (file)
@@ -56,7 +56,7 @@ check(const unsigned int testcase)
         std::swap(vertices[0], vertices[1]);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
 
index f9edac2f155ffe2cbda13781ff0e043258db39e8..7b4abdc16ae407ab03216e960a623aaa98dcefd2 100644 (file)
@@ -52,7 +52,7 @@ check(const unsigned int testcase)
         std::swap(vertices[1], vertices[0]);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
 
index df2dd72f3a1c7ef711bb8e36491f04faf2be1d6e..0a95b4aa925775a3348db8045bcf655e99f71e40 100644 (file)
@@ -549,7 +549,7 @@ HelmholtzProblem<dim>::refine_grid()
 
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
index 235c4ff57cd8e9e6dfb61d1609219ae1e592e2fe..1ef1ffe45fbc66d74e1b36e3936ae4f9c5fea235 100644 (file)
@@ -207,7 +207,7 @@ namespace Step51
           convection[2] = 1;
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return convection;
   }
index 998fa41af0a6adec022dc9ad854b771c4923e39a..4b13bde372d26afbf8f7658897e5b156ff5d3758 100644 (file)
@@ -207,7 +207,7 @@ namespace Step51
           convection[2] = 1;
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return convection;
   }
index 7ad5b6ff599b7fdcbf8f7cfc10ec7157b026adc8..4e4326ca0cbcd93831d537bc4f439fc733d0eca5 100644 (file)
@@ -426,7 +426,7 @@ HelmholtzProblem<dim>::refine_grid()
 
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -526,7 +526,7 @@ HelmholtzProblem<dim>::run()
             gmv_filename = "solution-adaptive";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       switch ((*fe).degree)
@@ -539,7 +539,7 @@ HelmholtzProblem<dim>::run()
             break;
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       gmv_filename += ".gmv";
@@ -584,7 +584,7 @@ HelmholtzProblem<dim>::run()
         error_filename += "-adaptive";
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   switch ((*fe).degree)
@@ -596,7 +596,7 @@ HelmholtzProblem<dim>::run()
         error_filename += "-q2";
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   error_filename += ".tex";
@@ -636,7 +636,7 @@ HelmholtzProblem<dim>::run()
             conv_filename += "-adaptive";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       switch ((*fe).degree)
         {
@@ -647,7 +647,7 @@ HelmholtzProblem<dim>::run()
             conv_filename += "-q2";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       conv_filename += ".tex";
 
index 3520cdab2a08ef116229d5355d7ba3569c5c0884..d24b68d65e67dfd1f89b5d503d5fd963b54135ab 100644 (file)
@@ -379,7 +379,7 @@ ElasticProblem<dim>::output_results(const unsigned int cycle) const
         solution_names.push_back("z_displacement");
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   data_out.add_data_vector(solution, solution_names);
index 566542264d9ef365d84fa4c377a94fdba3773cc7..c1c769a8687292eb5853b3b74987a8def9b3f1bf 100644 (file)
@@ -150,7 +150,7 @@ BEM<spacedim>::run()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   table.set_scientific("L^2 norm error", true);
   table.evaluate_convergence_rates("L^2 norm error",
index 027eb18a46c4643d9c6de10ff0afe0db239b6f58..37945867f26e7f3c29e3bd1e0414680b4d39713a 100644 (file)
@@ -111,7 +111,7 @@ public:
         case 1:
           return std::cos(p.norm());
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return 0;
       }
   }
index b1133fc40e1a20f6eff6472a9d5ad1ee0232008e..2378fc3940e8ff20c464789c0a4dc516766202c7 100644 (file)
@@ -114,7 +114,7 @@ public:
         case 1:
           return std::cos(p.norm());
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return 0;
       }
   }
index fc3a86835d73e0697a9e67c1d78aab28bd29ddba..0248af5b94c4c9b56e5acac6a7c41e654e427dbe 100644 (file)
@@ -114,7 +114,7 @@ public:
         case 1:
           return std::cos(p.norm());
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return 0;
       }
   }
index 97f3773a3b70d820f2f5a523b3efd350c6f5c069..3f5d450dd1395969215d71519c665ff3bff4ea7b 100644 (file)
@@ -114,7 +114,7 @@ public:
         case 1:
           return std::cos(p.norm());
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return 0;
       }
   }
index 5d4f6928c696e9bca1d56856ac0c769b4315400f..12176612a3bd2091b39df055ffb15ef1131e7524 100644 (file)
@@ -77,7 +77,7 @@ create_disconnected_mesh(Triangulation<dim> &tria)
 
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // Prepare cell data
@@ -129,7 +129,7 @@ create_disconnected_mesh(Triangulation<dim> &tria)
 
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     // Prepare cell data
index f100ac33c9722163e3f8ea1b865f4b4c2fc18750..5e1a1a31e2fd6b8e401c3daa0630cc9e60b28c54 100644 (file)
@@ -64,7 +64,7 @@ public:
         case 1:
           return std::cos(p[0]) * std::cos(3.0 * p[1]) + 2.0;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return 0.0;
   }
index 9367d65e3788bf4ee9cb9466c9926e70d02cbaf6..3a9d8d78db0227c5881ca41e550963a84d4875e9 100644 (file)
@@ -60,7 +60,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   /* A is
 
index 2256374ddd4eadc94fec5d703e0d0295038c7852..5ead7e9768542ee6bea25d2dcc135c044c9b885a 100644 (file)
@@ -90,7 +90,7 @@ transform_grid(Triangulation<2> &tria, const unsigned int transform)
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index 974dd8455125fdff9387d6e45d58f6bef02cf34e..bd16c1e819a0007b585a484925be92a107269289 100644 (file)
@@ -278,7 +278,7 @@ namespace Step36
         else if (cell->material_id() == pou_material_id)
           cell->set_active_fe_index(pou_fe_index);
         else
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     GridTools::partition_triangulation(n_mpi_processes, triangulation);
index afdd3e9d464e32af33450095d376e20a46458434..1bb4dfb12d4cca26e56559190b96e55970b87b7e 100644 (file)
@@ -288,7 +288,7 @@ namespace Step36
         else if (cell->material_id() == pou_material_id)
           cell->set_active_fe_index(pou_fe_index);
         else
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     GridTools::partition_triangulation(n_mpi_processes, triangulation);
index 3c361f247b88ab1da4646ec699782963f33a6fa3..fae4be3316517d41769efe890ba7c6698bafa1bf 100644 (file)
@@ -152,7 +152,7 @@ test(const Triangulation<dim> &tria,
                                           function1_back);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   DataOut<dim> data_out;
@@ -184,7 +184,7 @@ test(const Triangulation<dim> &tria,
         file2_name += fe_string2 + "_interpolation_diff.gnuplot";
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   deallog << file2_name << std::endl;
 
index fd644da08ed47ab88577f443cd6a87cdd1c5b939..72da21789986deb513ac116612ec4eb545d76fa0 100644 (file)
@@ -144,7 +144,7 @@ public:
             return point[1] + 0.25 * (2 * x - 1.0) * (x - 1.0) * x;
           }
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return std::numeric_limits<double>::quiet_NaN();
   }
@@ -171,7 +171,7 @@ public:
             return point[1] - 0.25 * (2 * x - 1.0) * (x - 1.0) * x;
           }
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     return std::numeric_limits<double>::quiet_NaN();
   }
index de550df9af76c0b2704247e172221029f2792238..14daeb67ce988d42d7dd0f81f76b279809f6f29a 100644 (file)
@@ -96,7 +96,7 @@ transform_grid(Triangulation<2> &tria, const unsigned int transform)
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index 0cccde4266e0b1896b8b64b51098d741fb69f253..a60a4cbdf936deb29be8f910dafa840f122be85d 100644 (file)
@@ -220,7 +220,7 @@ check(const FE_Q<dim> &fe)
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   // now check with data from the
index 13cddaf85bd125b18859356f2731a4a9ae95dab3..b770982d4ab9a62aa8e18bccbc51224b4928744f 100644 (file)
@@ -90,7 +90,7 @@ transform_grid(Triangulation<2> &tria, const unsigned int transform)
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index b5318daf6e7191549b68566fdedbb8d6578df0cc..ca3b57b86003e7255ef6c5ab802e2f5ae4966a4b 100644 (file)
@@ -86,7 +86,7 @@ transform_grid(Triangulation<2> &tria, const unsigned int transform)
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index 4a22c1041b6cb20b29ffac16bbb13d65013b4ccb..45cd0d5f7aef08949b60ec4c45bef141fb186ae0 100644 (file)
@@ -55,7 +55,7 @@ transform(const Point<dim> p)
                           p[1] * (1 + p[0]) * (1 + p[2]),
                           p[2] * (1 + p[0]) * (1 + p[1]));
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         return Point<dim>();
     };
 }
index 57b5be45a3b92907ff19c79d2fcb8c99dcb4f7c2..33f45ada954ba199180ef13b2fe5d22c67c3ac02 100644 (file)
@@ -38,7 +38,7 @@ template <int dim>
 void
 create_triangulation(const unsigned int, Triangulation<dim> &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -101,7 +101,7 @@ create_triangulation(const unsigned int case_no, Triangulation<2> &tria)
           //   *------------>x
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
@@ -170,7 +170,7 @@ create_triangulation(const unsigned int case_no, Triangulation<3> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index c67fcfb7afd0c7e8e26b161ada78bb3b9cce3ce2..1f907ca7375611f09450fceab527a622c2463bd1 100644 (file)
@@ -38,7 +38,7 @@ create_triangulation(const unsigned int case_no, Triangulation<1> &tria)
         GridGenerator::hyper_cube(tria, 1., 4.);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
@@ -62,7 +62,7 @@ create_triangulation(const unsigned int case_no, Triangulation<2> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
@@ -83,7 +83,7 @@ create_triangulation(const unsigned int case_no, Triangulation<3> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index 105eb55b1e4bfb47aecc54f5497624c56db6d89f..627f6c177739e1e6c7aca311da44c557780cd9ad 100644 (file)
@@ -88,7 +88,7 @@ test()
         coarsen_centers.push_back(Point<dim>(5. / 8., 5. / 8., 5. / 8.));
       }
     else
-      Assert(false, ExcNotImplemented());
+      DEAL_II_NOT_IMPLEMENTED();
 
     unsigned int index = 0;
     for (typename Triangulation<dim>::active_cell_iterator cell =
index 8352aa3c4fed5253daa863a79945ff956bb50835..2bdcacc2162c56fdabe274cf581bd1b7db7d1a63 100644 (file)
@@ -30,7 +30,7 @@ template <int dim>
 void
 create_triangulation(const unsigned int, Triangulation<dim> &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -55,7 +55,7 @@ create_triangulation(const unsigned int case_no, Triangulation<2> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
@@ -77,7 +77,7 @@ create_triangulation(const unsigned int case_no, Triangulation<3> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index 953750fcf2fa978ead27cf34b66d97a32259de33..0ddaf8599b992559ad182d76781fc0419e1829fa 100644 (file)
@@ -31,7 +31,7 @@ template <int dim>
 void
 create_triangulation(const unsigned int, Triangulation<dim> &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
@@ -61,7 +61,7 @@ create_triangulation(const unsigned int case_no, Triangulation<2> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
@@ -84,7 +84,7 @@ create_triangulation(const unsigned int case_no, Triangulation<3> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index bf64e43797b82f87a0c1a3c6da20b8aec99db35c..1f4a2b894a1b8632bfbdbe5907a7794b1e338c8b 100644 (file)
@@ -54,7 +54,7 @@ test(const int testcase)
           shift[d] = 1;
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   GridTools::shift(shift, tria_2);
 
index b299b6f36ce8f00458d36a4af828e9790e49e46d..2ef66801a3efbf769535a70f85fa28d158de64ae 100644 (file)
@@ -50,7 +50,7 @@ create_triangulation(const unsigned int case_no, Triangulation<3> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index c504d35ed18aa6fa66a2ac07c7b86277a851af60..d28afcdc9d05d889708afb10d17689b70e5596d7 100644 (file)
@@ -50,7 +50,7 @@ create_triangulation(const unsigned int case_no, Triangulation<2> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index 15902f76b61e4a6b8faabe322e3e66e2237a419e..0c34554f641807930692f798507ee968562da0e6 100644 (file)
@@ -52,7 +52,7 @@ create_triangulation(const unsigned int case_no, Triangulation<3> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index 6d06fcae81167b7ee47ee2a3428df312733f4242..accc1b9b6935010cc1f4a9649fb7f154b4736667 100644 (file)
@@ -52,7 +52,7 @@ create_triangulation(const unsigned int case_no, Triangulation<2> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index d9d0c81306d62b8e60c058a3714ed1d96a1df47b..3c94f08c98cbecacd8b8c7b30c4bf3d58a1519da 100644 (file)
@@ -49,7 +49,7 @@ create_triangulation(const unsigned int case_no, Triangulation<3> &tria)
           break;
         }
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     };
 }
 
index ff244ec5b0bc684a2f5fd6958e9917d7a27d93df..639b880cd7916509cbce2e3b601d3d9c80f9c243 100644 (file)
@@ -347,7 +347,7 @@ LaplaceProblem<dim>::estimate_smoothness(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   const unsigned      n_fourier_modes = k_vectors.size();
index aa1fc803e2273db79c2c3e696f6050ff6c68fd67..8b10cf8b407e63005606803f3cc8ac3c2866d2f9 100644 (file)
@@ -355,7 +355,7 @@ LaplaceProblem<dim>::estimate_smoothness(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   const unsigned      n_fourier_modes = k_vectors.size();
index 5ae1b279788335f5613c9389ffd17fc0a973d4b1..a21444ce545fafafe52e4c27d9d90bbaedaaeed5 100644 (file)
@@ -66,7 +66,7 @@ check()
         p2[1] = p2[2] = 1.0;
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   GridGenerator::subdivided_hyper_rectangle(triangulation,
index 562deea60235d0172edff26d71c3a249d30bd74c..9c02e46cee6e346afb22cc1e7709e1147a6b880e 100644 (file)
@@ -62,7 +62,7 @@ check()
         p2[1] = p2[2] = 1.0;
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   GridGenerator::subdivided_hyper_rectangle(triangulation,
index 3836d168e77b35eb3350d0f5e326cf3ebc769b93..49bf19cfc3ae9692b4218dc311358a1e12391ebf 100644 (file)
@@ -310,7 +310,7 @@ test_with_2d_deformed_refined_mesh(const hp::FECollection<dim> &fe)
             (std::next((++(triangulation.begin_active()))))->set_refine_flag();
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       triangulation.execute_coarsening_and_refinement();
 
index 6178db810213395a85f33646c463e1aede76dc91..497cbf914717864eace9c5cf1f5d70d438471355 100644 (file)
@@ -311,7 +311,7 @@ test_with_2d_deformed_refined_mesh(const hp::FECollection<dim> &fe)
             (std::next((++(triangulation.begin_active()))))->set_refine_flag();
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       triangulation.execute_coarsening_and_refinement();
 
index bc9aca3eb5290819ca2632eae1483b395c515685..2ff9f6021e63ee9e512d28e0e63a3b6b37887d20 100644 (file)
@@ -181,7 +181,7 @@ diffusionMechanics<dim>::set_active_fe_indices()
       else if (cell_is_in_omega2_domain(cell))
         cell->set_active_fe_index(1);
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 }
 
index 78f1a45b9b981d95ebb94b3b4e5639daed3bb1da..bcc0df00470dd89f5ec5ed6831dfd518c6a8eb50 100644 (file)
@@ -429,7 +429,7 @@ HelmholtzProblem<dim>::refine_grid()
 
       default:
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
     }
 }
@@ -529,7 +529,7 @@ HelmholtzProblem<dim>::run()
             gmv_filename = "solution-adaptive";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       switch ((*fe)[0].degree)
@@ -542,7 +542,7 @@ HelmholtzProblem<dim>::run()
             break;
 
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
 
       gmv_filename += ".gmv";
@@ -587,7 +587,7 @@ HelmholtzProblem<dim>::run()
         error_filename += "-adaptive";
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   switch ((*fe)[0].degree)
@@ -599,7 +599,7 @@ HelmholtzProblem<dim>::run()
         error_filename += "-q2";
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   error_filename += ".tex";
@@ -639,7 +639,7 @@ HelmholtzProblem<dim>::run()
             conv_filename += "-adaptive";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       switch ((*fe)[0].degree)
         {
@@ -650,7 +650,7 @@ HelmholtzProblem<dim>::run()
             conv_filename += "-q2";
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       conv_filename += ".tex";
 
index c6a79d88d9ad11918d2c259dea656b00f46d474a..a9fa3e026535584424674fdffcb93b3260cffdc7 100644 (file)
@@ -382,7 +382,7 @@ ElasticProblem<dim>::output_results(const unsigned int cycle) const
         solution_names.push_back("z_displacement");
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   data_out.add_data_vector(solution, solution_names);
index 4ec50667f05f38d839d4cef461408b0403380cc0..dea6bddb18fd9aff0a205d9dd5c082a1126d2548 100644 (file)
@@ -694,7 +694,7 @@ LaplaceProblem<dim>::estimate_smoothness(
         }
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   const unsigned      n_fourier_modes = k_vectors.size();
index 54cdbab535153a8fb70503621a79cbe186897d3d..f9207b88db90c1b2e827c4fc417f534ea6e41c61 100644 (file)
@@ -79,7 +79,7 @@ main()
                 break;
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             };
           ilu_pattern.compress();
 
index 8058461f54c06f543a012cecbf30b1c2b6175a34..833f06a7ffe34e530b81850274587858f7ce127b 100644 (file)
@@ -79,7 +79,7 @@ main()
                 break;
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             };
           ilu_pattern.compress();
           SparseILU<double>::AdditionalData data;
index 117a93b6115c5f84f9a9c9e5be60f93dbedbe013..7e8151c2b2b8eabb8e42bc1b8997bc99cd82155f 100644 (file)
@@ -82,7 +82,7 @@ main()
                 break;
 
               default:
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
             };
           mic_pattern.compress();
           SparseMIC<double>::AdditionalData data;
index 752653b4072ac71bad8173b9692388028fce469e..e1660a637b535547ace5b7d0194dda231a5fec76 100644 (file)
@@ -220,7 +220,7 @@ create_triangulations(std::vector<Triangulation<dim> *> &,
                       std::vector<Manifold<dim> *> &,
                       std::vector<double> &)
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 
index d0906f29ec7249f0f556aeb938e3286a4514f813..0175a37343e039b67e63182a0820710da674f9b0 100644 (file)
@@ -67,7 +67,7 @@ test(const unsigned int geometry      = 0,
   else if (geometry == 2)
     GridGenerator::hyper_ball(tria);
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   tria.reset_all_manifolds();
 
index 7a29312e68e14c76600a5371e18e389d9f74dd85..5fc22b2a04c5d1276a1641557df42829f806c5e9 100644 (file)
@@ -69,7 +69,7 @@ test(const unsigned int geometry      = 0,
   else if (geometry == 2)
     GridGenerator::hyper_ball(tria);
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   tria.reset_all_manifolds();
 
index 1030c3e13ac003c4ecfe9f9dacb1d46ff88bbdd9..091f805680de8f4a914a438efdbafff972a20d73 100644 (file)
@@ -93,7 +93,7 @@ main()
       else if (cell->reference_cell() == ReferenceCells::Quadrilateral)
         cell->set_active_fe_index(1);
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   const hp::MappingCollection<2> mapping(MappingFE<2>(FE_SimplexP<2>(1)),
index 484482f6a2f5614bb55ffb5bd68c5c1a86ef077d..d914517a4cf21851da1b58b10ceba89782e4e99d 100644 (file)
@@ -80,7 +80,7 @@ get_penalty_parameter(const unsigned int i,
         return 64.0;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return 0.0;
 }
index 94ec8f27d8d38f81d6cc7a6e3e66ec735d4cce85..a5c4903cbba5b1147d3b88bae28a4ef698944e95 100644 (file)
@@ -271,7 +271,7 @@ namespace StokesClass
       // iterations of our two-stage outer GMRES iteration)
       if (do_solve_A == true)
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
       else
         {
@@ -559,7 +559,7 @@ namespace StokesClass
   void
   StokesOperator<dim, degree_v, number>::compute_diagonal()
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
index a67705df33fcab81a9b704183ac886a3a38c24aa..e362142d431894996b44f53f98db5b1ca242a4bd 100644 (file)
@@ -236,7 +236,7 @@ MatrixFreeTest<dim, fe_degree, Number, VectorType, n_q_points_1d>::el(
   const unsigned int col) const
 {
   (void)col;
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
   return 0.;
 }
 
index 69517b6ab8119df27aceea65ae3b637277251bd0..cf026bc475ebff49d84fc41768bbdce4cde080a5 100644 (file)
@@ -66,7 +66,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(row_partitioning,
                                        col_partitioning,
index 45dcad00c18536f09a2dbe5c95d0d56a278328f6..bf21853764a8a183fdf5b34d9afb14184edf13fe 100644 (file)
@@ -66,7 +66,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(row_partitioning,
                                        col_partitioning,
index f154d53a0b0fd9161386c57b585663dfdc2b9e77..7baca4327ef4ebb79b464b8c953f268909f8e940 100644 (file)
@@ -62,7 +62,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(row_partitioning,
                                        col_partitioning,
index fbd6270f8f06acffb8d1cf36e16c61ad41aaa0fb..4f06dc0590dd742c770ba6a6e07174b881525b88 100644 (file)
@@ -66,7 +66,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(row_partitioning,
                                        col_partitioning,
index cb08203bb8be4ecdc8727575b126f71afc03aa7f..306a81dcca2bacb89d24d489f7bc6f02a1f38fdc 100644 (file)
@@ -55,7 +55,7 @@ test()
         locally_owned.add_range(2, n_rows);
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(locally_owned,
                                        locally_owned,
index 3fa26883c4d697ef0c7ccde8b394790a0229224d..87c43cf1a410d524621b061026dc11b2e63d79cd 100644 (file)
@@ -65,7 +65,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(row_partitioning,
                                        col_partitioning,
index f70e0579a4714c9425c8fd7c2f51340f0283afb8..86d5b4399537002677a34fbe16fbd86280bef528 100644 (file)
@@ -66,7 +66,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(row_partitioning,
                                        col_partitioning,
index 2409e7eea0198eaba801a3c509ba73a82b00344f..5e65c860ba24d59c1faef3f9473979fc8e3894b8 100644 (file)
@@ -69,7 +69,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(row_partitioning,
                                        col_partitioning,
index b556b8b7c7d21f0008ef196d17cb06516dc7488d..cf0f1ea6f9f9f9c52105acf8a73bbb7982396873 100644 (file)
@@ -63,7 +63,7 @@ test()
         }
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   TrilinosWrappers::SparsityPattern sp(row_partitioning,
                                        col_partitioning,
index a0a65e1db2ef91f511725c8ae1c82bc792f4367f..16e84b1325e94b9212f13698a87bd13abe30e256 100644 (file)
@@ -114,7 +114,7 @@ public:
   Number
   el(unsigned int, unsigned int) const
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
     return 0;
   }
 
index 381497b1a40b084313ccdc6535ad6612caa8741b..9dcabfd4e2c49df457dea046569e6255e106318c 100644 (file)
@@ -271,7 +271,7 @@ namespace StokesClass
       // iterations of our two-stage outer GMRES iteration)
       if (do_solve_A == true)
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
       else
         {
@@ -559,7 +559,7 @@ namespace StokesClass
   void
   StokesOperator<dim, degree_v, number>::compute_diagonal()
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
index de5b97f28230e91b4def18c4c101bc7c4f7ffb25..04b6fde47609f2c720bf62d1b9fabb12d90dd1b6 100644 (file)
@@ -70,7 +70,7 @@ public:
           v(2) = p[2];
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   }
 };
index c5fdc721d0d207e83d219a446f73f411806c6a33..0f85515e2f814c9ca9ab9ce7d6d7d62a7f7a9215 100644 (file)
@@ -272,7 +272,7 @@ namespace StokesClass
       // iterations of our two-stage outer GMRES iteration)
       if (do_solve_A == true)
         {
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
         }
       else
         {
@@ -560,7 +560,7 @@ namespace StokesClass
   void
   StokesOperator<dim, degree_v, number>::compute_diagonal()
   {
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
   }
 
 
index cb01e0ac5f49914133675f9d5af0fa02fd9aaf3f..88c1007a456cb7445e95c6c9fe325df36a3a7b90 100644 (file)
@@ -64,7 +64,7 @@ public:
           v(2) = p[2];
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   }
 };
index 65599112906e28df24daeb0af847b9cdee971a94..4215b7a2ac62d460e9743fa5530ca72d69428c97 100644 (file)
@@ -334,7 +334,7 @@ test_with_2d_deformed_refined_mesh(const FiniteElement<dim> &fe,
             (std::next((++(triangulation.begin_active()))))->set_refine_flag();
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       triangulation.execute_coarsening_and_refinement();
 
index 48ca336f1fb6aad473fb01a5aeb8358d88ee8b30..2a275ea703c476b14975c51b02d76e92dff35a4d 100644 (file)
@@ -347,7 +347,7 @@ test_with_2d_deformed_refined_mesh(const FiniteElement<dim> &fe,
             (std::next((++(triangulation.begin_active()))))->set_refine_flag();
             break;
           default:
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
         }
       triangulation.execute_coarsening_and_refinement();
 
index c3f5f3304947d29fe4d8bbd6053b2d43d9144dd1..5a0f4a89c899dfff16e19934c1029c94181442d6 100644 (file)
@@ -246,7 +246,7 @@ test(const unsigned int poly_degree)
           exact[3] = std::complex<double>(3. * pi, 1. - 6. * pi2) / (36. * pi3);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
         break;
     }
 
index 03ad4d0004d80ce796f706a1f77bead34b4d8006..55834757967085ddc5df665fb5e421f667590c51 100644 (file)
@@ -544,7 +544,7 @@ namespace NavierStokes_DG
       }
     else
       {
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
       }
 #else
     (void)subcommunicator;
index cf67034d8b96ae0bc43e05c3ba88a60331dde511..f71d3a81b4c1ea2e721cb6cd479968ac0df418ef 100644 (file)
@@ -32,5 +32,5 @@ main()
   else if (typeid(PetscScalar) == typeid(float))
     deallog << "float" << std::endl;
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
index c60f5b5e5c9fe97c15f4da2e1beb4b9e43354f67..20fc1e874a59eeb1b286cad39361fe286366d42c 100644 (file)
@@ -216,7 +216,7 @@ namespace Euler_DG
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return 0.;
       }
   }
@@ -626,7 +626,7 @@ namespace Euler_DG
 
         default:
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return {};
           }
       }
@@ -2060,7 +2060,7 @@ namespace Euler_DG
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     triangulation.refine_global(n_global_refinements);
index 24d69d679b5ad0e6ff8c1224a871b3c1295101d2..441fe0abfe8fdfd40c8039bf5621f5194ba1e167 100644 (file)
@@ -515,7 +515,7 @@ namespace Step18
           solution_names.push_back("delta_z");
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     data_out.add_data_vector(incremental_displacement, solution_names);
     Vector<double> norm_of_stress(triangulation.n_active_cells());
index ba5760246df2793f7fc9cad73da07823542e40c0..dcde1e8266c188bbe735726592fa2824dfb5e345 100644 (file)
@@ -531,7 +531,7 @@ namespace Step18
           solution_names.push_back("delta_z");
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
     data_out.add_data_vector(incremental_displacement, solution_names);
     Vector<double> norm_of_stress(triangulation.n_active_cells());
index efc035cee9c264dc025a17d6b801bb4d880e302d..52f31335c0dfaf7a30e3ec2b5dab900549d93778 100644 (file)
@@ -164,7 +164,7 @@ test()
         if (std::abs(evaluation_points[i][0] - evaluation_point_results[i]) >
               1e-10 ||
             std::abs(evaluation_point_gradient_results[i][0] - 1.0) > 1e-10)
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
   deallog << "OK!" << std::endl;
index 9b1d78b8c8efd2fea33b25db2af88308de07edbc..a19ac97833e96bcd06b315671cf9ad73335187ae 100644 (file)
@@ -127,7 +127,7 @@ test()
                      evaluation_point_results_2[i]) > 1e-10 ||
             std::abs(evaluation_point_results_1[i] -
                      evaluation_point_results_3[i]) > 1e-10)
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
   deallog << "OK!" << std::endl;
index 8c5d0ebc134397d3429f1dcfa05cfb7bf512d70f..d3994b3abc719dbcf558e45dac5badef86364247 100644 (file)
@@ -83,7 +83,7 @@ template <int dim>
 void
 test()
 {
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 }
 
 template <>
index 2a854b1fc2c40e67db0393bcb2e20181a4cd9b4c..b049d41ff84f6219300abcedf215a7d3a275fdf7 100644 (file)
@@ -91,7 +91,7 @@ test(const FiniteElement<dim, spacedim> &fe_0,
       else if (cell->reference_cell() == ReferenceCells::Quadrilateral)
         cell->set_active_fe_index(1);
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   dof_handler.distribute_dofs(fe);
index e7bae19ead6dce944e936af5561c4dc242b801cd..9f244ec568ed50c9dc8cb33f5bbf36eeaa255f21 100644 (file)
@@ -163,7 +163,7 @@ test(const unsigned int v, const unsigned int degree, const bool do_helmholtz)
       fe_mapping = std::make_shared<FE_PyramidP<dim>>(1);
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   MappingFE<dim> mapping(*fe_mapping);
 
@@ -326,7 +326,7 @@ main(int argc, char **argv)
       else if (i == 2)
         deallog.push("PYRAMID");
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
       if (i == 0) // 2D makes only sense for simplex
         {
index 22d393c690d084c2e196e7c3544958f8fbcf78a9..1de353dfef4fddc232f3533c48b4bb148ba0f945 100644 (file)
@@ -82,7 +82,7 @@ get_penalty_parameter(const unsigned int i,
         return 64.0;
     }
 
-  Assert(false, ExcNotImplemented());
+  DEAL_II_NOT_IMPLEMENTED();
 
   return 0.0;
 }
index 7fd11dfbb6bdcc05c432d25f947bd06b039e1073..3b24dc2b45d121f6d3b998fd1bad2a9f1ca71ff6 100644 (file)
@@ -93,7 +93,7 @@ test(const unsigned int v, const unsigned int degree)
                                             QGaussSimplex<dim - 1>(degree + 1)};
     }
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 
   MappingFE<dim> mapping(*fe_mapping);
 
@@ -219,7 +219,7 @@ main(int argc, char **argv)
       else if (i == 2)
         deallog.push("PYRAMID");
       else
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
 
       if (i == 0) // 2D makes only sense for simplex
         {
index 220277bc54a48282c4a39ab1ea2cc53c7bd9b23c..ad66b09ad87fe2bd0e973030eb9e8f6eee1c752b 100644 (file)
@@ -425,7 +425,7 @@ namespace Step7
 
         default:
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
           }
       }
   }
@@ -549,7 +549,7 @@ namespace Step7
           vtk_filename = "solution-adaptive";
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     switch (fe->degree)
@@ -562,7 +562,7 @@ namespace Step7
           break;
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     vtk_filename += ".vtk";
@@ -611,7 +611,7 @@ namespace Step7
           error_filename += "-adaptive";
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     switch (fe->degree)
@@ -623,7 +623,7 @@ namespace Step7
           error_filename += "-q2";
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     error_filename += ".tex";
@@ -664,7 +664,7 @@ namespace Step7
               conv_filename += "-adaptive";
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         switch (fe->degree)
           {
@@ -675,7 +675,7 @@ namespace Step7
               conv_filename += "-q2";
               break;
             default:
-              Assert(false, ExcNotImplemented());
+              DEAL_II_NOT_IMPLEMENTED();
           }
         conv_filename += ".tex";
 
index 120b5e5b25a63dced575bf58ed8ad014b6e69df1..5ca546b99fcd727a3512feb9ca161b2481959541 100644 (file)
@@ -301,7 +301,7 @@ namespace Step8
           solution_names.emplace_back("z_displacement");
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 
     data_out.add_data_vector(solution, solution_names);
index 66c9a8f3854abcb05bdbc9888ae9dfbb6032ac35..5693d681d895561142e36b5146da7d709215f7af 100644 (file)
@@ -242,7 +242,7 @@ namespace Euler_DG
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
           return 0.;
       }
   }
@@ -653,7 +653,7 @@ namespace Euler_DG
 
         default:
           {
-            Assert(false, ExcNotImplemented());
+            DEAL_II_NOT_IMPLEMENTED();
             return {};
           }
       }
@@ -2187,7 +2187,7 @@ namespace Euler_DG
           }
 
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
 #ifdef HEX
     triangulation.refine_global(n_global_refinements);
index 0ff6ef5a2c165b2d400ea4cd56711a9fa999fac7..9f0d1bd241fdff9ea587c5c829b49e255ed3e9bb 100644 (file)
@@ -915,7 +915,7 @@ namespace Step74
               }
             default:
               {
-                Assert(false, ExcNotImplemented());
+                DEAL_II_NOT_IMPLEMENTED();
               }
           }
         deallog << "  Number of active cells       : "
index 29f56f7734b1cfd4f4c6135b50641d3bf8c0e1a2..5ac5309797cade3f9c487e9866affc7ee34dedc7 100644 (file)
@@ -104,7 +104,7 @@ check_solve(SolverType               &solver,
                                   51);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   deallog << "Eigenvalues:";
index f3ac7b63e40f24320e4c48f5b06a3511f865b24c..d3cad40cd78820906337640554c48a4b7d802913 100644 (file)
@@ -28,7 +28,7 @@ print_type(const Tensor<2, dim, number> &)
   else if (std::is_same_v<number, double>)
     deallog << " Tensor<2, " << dim << ", double>" << std::endl;
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
 
 template <int dim, typename number>
index ba52f26a3d26b10f197d125d5f5828a49d048b8e..7fa9f585b8b4f91c7db0ef396204d58462b11656 100644 (file)
@@ -107,7 +107,7 @@ test()
         break;
 
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
   check(A);
 }
index 1ad9d0b984192931a9b42195b57b1d511080a2a1..b20ff19b2be8ca973210bcdf11bcfdd8d5ae03c1 100644 (file)
@@ -38,5 +38,5 @@ main(int argc, char **argv)
   else if (typeid(TrilinosScalar) == typeid(float))
     deallog << "float" << std::endl;
   else
-    Assert(false, ExcNotImplemented());
+    DEAL_II_NOT_IMPLEMENTED();
 }
index dac438fa0e26a20f65a1b2de0eaab84c5888e975..4779eba3746e71d0758d36c7544390b0ef26c0a5 100644 (file)
@@ -199,7 +199,7 @@ test()
                                   26);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   SolverCG<Vector<double>> cg(control,
@@ -226,7 +226,7 @@ test()
                                   26);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   deallog << "Sparse Factorization" << std::endl;
index 357088f75697603aeb37f954056ce6117365aa09..e853b83306252656b78e51728357a4b062a104d1 100644 (file)
@@ -75,7 +75,7 @@ public:
           values[5] = 2 * (p[2] + p[0] * p[1]);
           break;
         default:
-          Assert(false, ExcNotImplemented());
+          DEAL_II_NOT_IMPLEMENTED();
       }
   }
 };
@@ -147,7 +147,7 @@ test()
         true_value = std::sqrt(29.0 / 3.0);
         break;
       default:
-        Assert(false, ExcNotImplemented());
+        DEAL_II_NOT_IMPLEMENTED();
     }
 
   test<dim>(VectorTools::Hdiv_seminorm, true_value);

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.