]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated LevelSet namespace 15543/head
authorDaniel Arndt <arndtd@ornl.gov>
Thu, 29 Jun 2023 15:53:49 +0000 (11:53 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Fri, 30 Jun 2023 19:07:40 +0000 (15:07 -0400)
12 files changed:
doc/news/changes/incompatibilities/202306230DanielArndt [new file with mode: 0644]
include/deal.II/base/function_level_set.h [deleted file]
tests/base/function_signed_distance_01.cc
tests/base/function_signed_distance_04.cc
tests/non_matching/discrete_quadrature_generator.cc
tests/non_matching/face_quadrature_generator.cc
tests/non_matching/fe_values.cc
tests/non_matching/mesh_classifier.cc
tests/non_matching/quadrature_generator.cc
tests/non_matching/quadrature_generator_sphere.cc
tests/non_matching/root_finder.cc
tests/non_matching/up_through_dimension_creator.cc

diff --git a/doc/news/changes/incompatibilities/202306230DanielArndt b/doc/news/changes/incompatibilities/202306230DanielArndt
new file mode 100644 (file)
index 0000000..343c79f
--- /dev/null
@@ -0,0 +1,4 @@
+Removed: The deprecated Functions::LevelSet namespace
+has been removed
+<br>
+(Daniel Arndt, 2023/06/30) 
diff --git a/include/deal.II/base/function_level_set.h b/include/deal.II/base/function_level_set.h
deleted file mode 100644 (file)
index bbe096e..0000000
+++ /dev/null
@@ -1,40 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2019 - 2021 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-#ifndef dealii_function_level_set_h
-#define dealii_function_level_set_h
-
-#include <deal.II/base/config.h>
-
-#include <deal.II/base/function_signed_distance.h>
-
-DEAL_II_NAMESPACE_OPEN
-
-namespace Functions
-{
-  namespace LevelSet
-  {
-    template <int dim>
-    using Sphere DEAL_II_DEPRECATED = SignedDistance::Sphere<dim>;
-
-    template <int dim>
-    using Plane DEAL_II_DEPRECATED = SignedDistance::Plane<dim>;
-
-  } // namespace LevelSet
-} // namespace Functions
-
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
index 9bba700df6336cd8cc359b37fc92fae00bd41c0e..3c78773704257a5780d8a3928a41812e5fc7df89 100644 (file)
@@ -20,7 +20,7 @@
  * what the function values should be.
  */
 
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 
 #include "../tests.h"
 
index b71ca257cd130d64d5de6ecc53fa53251f5e460e..87abdb3648c64685224701b4d4503a8f55f18c3b 100644 (file)
@@ -19,7 +19,7 @@
  * what the function values should be.
  */
 
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 
 #include "../tests.h"
 
index a9e25dbcdbae9a2f582d06e44c170cf1c424344a..87d1be03ce93415686427c18913b669509040e11 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 #include <deal.II/base/exceptions.h>
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 #include <deal.II/base/quadrature_lib.h>
 
 #include <deal.II/fe/fe_q.h>
@@ -114,7 +114,7 @@ Test<dim>::setup_discrete_level_set()
 {
   Point<dim> point_on_zero_contour;
   point_on_zero_contour[0] = 1.5;
-  const Functions::LevelSet::Plane<dim> analytical_levelset(
+  const Functions::SignedDistance::Plane<dim> analytical_levelset(
     point_on_zero_contour, Point<dim>::unit_vector(0));
 
   level_set.reinit(dof_handler.n_dofs());
index c5eaf604ec420a4b47b2b4d3a8973389e9479c34..dd1db31cdaf910cf4eb16eb90255b1e8b90ccded 100644 (file)
@@ -23,7 +23,7 @@
  * quadratures.
  */
 
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 #include <deal.II/base/geometry_info.h>
 #include <deal.II/base/quadrature_lib.h>
 
@@ -85,7 +85,7 @@ test_plane_cuts_through_center()
   for (int plane_direction = 0; plane_direction < dim; ++plane_direction)
     {
       const Tensor<1, dim> normal = Point<dim>::unit_vector(plane_direction);
-      const Functions::LevelSet::Plane<dim> levelset(center, normal);
+      const Functions::SignedDistance::Plane<dim> levelset(center, normal);
 
       // Test all faces that are intersected by the plane.
       for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
@@ -118,10 +118,10 @@ test_1D()
 {
   deallog << "test_1D" << std::endl;
 
-  const int                             dim = 1;
-  Point<dim>                            center(.5);
-  const Tensor<1, dim>                  normal = Point<dim>::unit_vector(0);
-  const Functions::LevelSet::Plane<dim> levelset(center, normal);
+  const int            dim = 1;
+  Point<dim>           center(.5);
+  const Tensor<1, dim> normal = Point<dim>::unit_vector(0);
+  const Functions::SignedDistance::Plane<dim> levelset(center, normal);
 
   for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
     {
index 3e0e4b9dc432e084c7a2f8e3ba75b027dcc98579..06a1c15b443c936ad5bfc4a7603e88daafbdda43 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 #include <deal.II/base/exceptions.h>
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 #include <deal.II/base/quadrature_lib.h>
 #include <deal.II/base/std_cxx17/optional.h>
 
@@ -188,7 +188,7 @@ Test<dim>::setup_discrete_level_set()
 {
   Point<dim> point_on_zero_contour;
   point_on_zero_contour[0] = 1.5;
-  const Functions::LevelSet::Plane<dim> analytical_levelset(
+  const Functions::SignedDistance::Plane<dim> analytical_levelset(
     point_on_zero_contour, Point<dim>::unit_vector(0));
 
   level_set.reinit(dof_handler.n_dofs());
index cc6d72721b485ea9d147f7d2258064d0e26fd5bd..ddf595da56e838a759f82bbf63bb6f84652fe468 100644 (file)
@@ -18,7 +18,7 @@
 
 #include <deal.II/base/exceptions.h>
 #include <deal.II/base/function.h>
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 #include <deal.II/base/point.h>
 
 #include <deal.II/dofs/dof_handler.h>
@@ -202,7 +202,7 @@ test_intersection_x_eq_0_plane()
   plane_normal[0] = 1;
   const Point<dim> origo;
 
-  const Functions::LevelSet::Plane<dim> level_set(origo, plane_normal);
+  const Functions::SignedDistance::Plane<dim> level_set(origo, plane_normal);
 
   classify_with_discrete_and_analytic_level_set(level_set);
 }
index 75cc606cc612859fe63d0b812dcc3086b82a6f74..8e418410e377a37b148234ff714a55b68129df66 100644 (file)
@@ -23,7 +23,7 @@
  */
 
 #include <deal.II/base/function.h>
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 #include <deal.II/base/point.h>
 #include <deal.II/base/quadrature_lib.h>
 #include <deal.II/base/symmetric_tensor.h>
@@ -98,7 +98,7 @@ test_vertical_cuts_through_center()
     {
       deallog << "direction=" << direction << std::endl;
       const Tensor<1, dim> normal = Point<dim>::unit_vector(direction);
-      const Functions::LevelSet::Plane<dim> level_set(center, normal);
+      const Functions::SignedDistance::Plane<dim> level_set(center, normal);
       create_and_print_quadratures(level_set);
     }
 }
@@ -152,7 +152,7 @@ test_simplex_cut()
   Point<dim> point_in_plane;
   point_in_plane[0] = edge_length;
 
-  const Functions::LevelSet::Plane<dim> level_set(point_in_plane, normal);
+  const Functions::SignedDistance::Plane<dim> level_set(point_in_plane, normal);
 
   create_and_print_quadratures(level_set);
 }
@@ -176,7 +176,7 @@ test_epsilon_cut_at_bottom_corner()
       normal[i] = 1;
       center(i) += epsilon;
     }
-  const Functions::LevelSet::Plane<dim> level_set(center, normal);
+  const Functions::SignedDistance::Plane<dim> level_set(center, normal);
 
   create_and_print_quadratures(level_set);
 }
@@ -204,7 +204,7 @@ test_sphere_cutting_corner_exactly()
   const double radius = 4;
   Point<dim>   center;
   center[dim - 1] = radius;
-  const Functions::LevelSet::Sphere<dim> level_set(center, radius);
+  const Functions::SignedDistance::Sphere<dim> level_set(center, radius);
 
   typename QuadratureGenerator<dim>::AdditionalData data;
   data.split_in_half  = false;
index 4ed0361cbe5b31c23b2e180f77652b9ad5290971..c60612d0869054dd400257b15af99fc9445ef04b 100644 (file)
@@ -13,7 +13,7 @@
 //
 // ---------------------------------------------------------------------
 
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 #include <deal.II/base/quadrature.h>
 #include <deal.II/base/quadrature_lib.h>
 
@@ -48,7 +48,7 @@ calculate_volume_and_surface_area()
 
 
   // Description of the immersed domain.
-  const Functions::LevelSet::Sphere<dim> level_set;
+  const Functions::SignedDistance::Sphere<dim> level_set;
 
   // Create a quadrature generator.
   const hp::QCollection<1>              q_collection1D(QGauss<1>(2));
index f77027204d474bcbc2dd9718c1d5791ae8475f85..de9ea41a60e76f70544ffcf1c3818bb3fed0d8b8 100644 (file)
@@ -18,8 +18,8 @@
  */
 
 #include <deal.II/base/bounding_box.h>
-#include <deal.II/base/function_level_set.h>
 #include <deal.II/base/function_lib.h>
+#include <deal.II/base/function_signed_distance.h>
 #include <deal.II/base/geometry_info.h>
 #include <deal.II/base/point.h>
 #include <deal.II/base/tensor.h>
@@ -66,7 +66,7 @@ test_roots_sorted_not_duplicated()
 {
   deallog << "test_roots_sorted_not_duplicated" << std::endl;
 
-  std::vector<Functions::LevelSet::Plane<1>> linear_functions;
+  std::vector<Functions::SignedDistance::Plane<1>> linear_functions;
 
   const std::vector<double> roots = {.75, .25, .25};
   for (unsigned int i = 0; i < roots.size(); ++i)
@@ -74,7 +74,8 @@ test_roots_sorted_not_duplicated()
       Tensor<1, 1> normal;
       normal[0] = 1;
       const Point<1> point(roots.at(i));
-      linear_functions.push_back(Functions::LevelSet::Plane<1>(point, normal));
+      linear_functions.push_back(
+        Functions::SignedDistance::Plane<1>(point, normal));
     }
 
   const std::vector<std::reference_wrapper<const Function<1>>> functions(
index 653be417bb49ae5be6da054250fcb21ec0f6c62b..20f711d4b94d60eea3385a2e977e64e0f7abae55 100644 (file)
@@ -18,7 +18,7 @@
  * in NonMatching::internal::QuadratureGeneratorImplementation.
  */
 
-#include <deal.II/base/function_level_set.h>
+#include <deal.II/base/function_signed_distance.h>
 #include <deal.II/base/quadrature_lib.h>
 
 #include <deal.II/hp/q_collection.h>
@@ -96,8 +96,8 @@ test_cut_through_center()
 
   Point<dim>     point_through_plane = .5 * Point<dim>::unit_vector(dim - 1);
   Tensor<1, dim> plane_normal        = Point<dim>::unit_vector(dim - 1);
-  const Functions::LevelSet::Plane<dim> level_set(point_through_plane,
-                                                  plane_normal);
+  const Functions::SignedDistance::Plane<dim> level_set(point_through_plane,
+                                                        plane_normal);
 
   create_and_print_partitioning(level_set);
 }
@@ -121,7 +121,8 @@ test_missed_roots_on_bottom_face()
   const Tensor<1, dim> plane_normal = Point<dim>::unit_vector(dim - 1);
   Point<dim>           point_in_plane;
   point_in_plane[dim - 1] = -.1;
-  const Functions::LevelSet::Plane<dim> level_set(point_in_plane, plane_normal);
+  const Functions::SignedDistance::Plane<dim> level_set(point_in_plane,
+                                                        plane_normal);
 
   create_and_print_partitioning(level_set);
 }
@@ -141,7 +142,8 @@ test_missed_roots_on_top_face()
   const Tensor<1, dim> plane_normal = Point<dim>::unit_vector(dim - 1);
   Point<dim>           point_in_plane;
   point_in_plane[dim - 1] = 1.1;
-  const Functions::LevelSet::Plane<dim> level_set(point_in_plane, plane_normal);
+  const Functions::SignedDistance::Plane<dim> level_set(point_in_plane,
+                                                        plane_normal);
 
   create_and_print_partitioning(level_set);
 }

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.