From 49b358af5d8a457b54b0317460f124c03c5744fc Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Fri, 5 Jun 2020 17:02:31 -0400 Subject: [PATCH] Remove deprecated OpenCASCADE classes --- include/deal.II/opencascade/boundary_lib.h | 190 ------------------ source/opencascade/CMakeLists.txt | 2 - source/opencascade/boundary_lib.cc | 60 ------ source/opencascade/boundary_lib.inst.in | 28 --- tests/fail/arclength_boundary_02.cc | 2 +- tests/gmsh/create_tria_02.cc | 2 +- tests/opencascade/arclength_boundary_01.cc | 2 +- .../arclength_boundary_from_iges_01.cc | 2 +- .../arclength_boundary_from_step_01.cc | 2 +- tests/opencascade/axis_boundary_02.cc | 6 +- tests/opencascade/create_tria_00.cc | 2 +- tests/opencascade/create_tria_01.cc | 4 +- tests/opencascade/create_tria_02.cc | 2 +- tests/opencascade/directional_boundary_01.cc | 4 +- .../interpolation_curve_boundary.cc | 4 +- .../interpolation_curve_boundary_02.cc | 2 +- tests/opencascade/manifold_clone_01.cc | 26 +-- tests/opencascade/manifold_clone_01.output | 3 - tests/opencascade/normal_projection_01.cc | 4 +- .../normal_to_mesh_projection_01.cc | 4 +- .../normal_to_mesh_projection_02.cc | 4 +- .../normal_to_mesh_projection_03.cc | 4 +- .../opencascade/nurbs_patches_manifold_00.cc | 2 +- tests/opencascade/project_center_cell_01.cc | 4 +- 24 files changed, 30 insertions(+), 335 deletions(-) delete mode 100644 include/deal.II/opencascade/boundary_lib.h delete mode 100644 source/opencascade/boundary_lib.cc delete mode 100644 source/opencascade/boundary_lib.inst.in diff --git a/include/deal.II/opencascade/boundary_lib.h b/include/deal.II/opencascade/boundary_lib.h deleted file mode 100644 index 230af95676..0000000000 --- a/include/deal.II/opencascade/boundary_lib.h +++ /dev/null @@ -1,190 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2014 - 2018 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_occ_boundary_lib_h -# define dealii_occ_boundary_lib_h - -# include - -# ifdef DEAL_II_WITH_OPENCASCADE - -# include - -DEAL_II_NAMESPACE_OPEN - -/** - * @addtogroup OpenCASCADE - * @{ - */ - -namespace OpenCASCADE -{ - /** - * A Manifold object based on OpenCASCADE TopoDS_Shape where new points are - * first computed by averaging the surrounding points in the same way as - * FlatManifold does, and are then projected in the normal direction using - * OpenCASCADE utilities. - * - * This class makes no assumptions on the shape you pass to it, and the - * topological dimension of the Manifold is inferred from the TopoDS_Shape - * itself. In debug mode there is a sanity check to make sure that the - * surrounding points (the ones used in project_to_manifold()) actually live - * on the Manifold, i.e., calling OpenCASCADE::closest_point() on those - * points leaves them untouched. If this is not the case, an - * ExcPointNotOnManifold is thrown. - * - * This could happen, for example, if you are trying to use a shape of type - * TopoDS_Edge when projecting on a face. In this case, the vertices of the - * face would be collapsed to the edge, and your surrounding points would - * not be lying on the given shape, raising an exception. - * - * - * @deprecated Use NormalProjectionManifold instead, which is identical to - * this class but satisfies the modern Manifold-based naming convention. - */ - template - class DEAL_II_DEPRECATED NormalProjectionBoundary - : public NormalProjectionManifold - { - public: - /** - * Inherit all constructors. - */ - using NormalProjectionManifold::NormalProjectionManifold; - - /** - * Clone the current Manifold. - */ - virtual std::unique_ptr> - clone() const override; - }; - - /** - * A Manifold object based on OpenCASCADE TopoDS_Shape where new points are - * first computed by averaging the surrounding points in the same way as - * FlatManifold does, and then projecting them onto the manifold along the - * direction specified at construction time using OpenCASCADE utilities. - * - * This class makes no assumptions on the shape you pass to it, and the - * topological dimension of the Manifold is inferred from the TopoDS_Shape - * itself. In debug mode there is a sanity check to make sure that the - * surrounding points (the ones used in project_to_manifold()) actually live - * on the Manifold, i.e., calling OpenCASCADE::closest_point() on those - * points leaves them untouched. If this is not the case, an - * ExcPointNotOnManifold is thrown. - * - * Notice that this type of Manifold descriptor may fail to give results if - * the triangulation to be refined is close to the boundary of the given - * TopoDS_Shape, or when the direction you use at construction time does not - * intersect the shape. An exception is thrown when this happens. - * - * - * @deprecated Use DirectionalProjectionManifold instead, which is identical to - * this class but satisfies the modern Manifold-based naming convention. - */ - template - class DEAL_II_DEPRECATED DirectionalProjectionBoundary - : public DirectionalProjectionManifold - { - public: - /** - * Inherit all constructors. - */ - using DirectionalProjectionManifold:: - DirectionalProjectionManifold; - - /** - * Clone the current Manifold. - */ - virtual std::unique_ptr> - clone() const override; - }; - - - /** - * A Manifold object based on OpenCASCADE TopoDS_Shape where new points are - * first computed by averaging the surrounding points in the same way as - * FlatManifold does, and then projecting them using OpenCASCADE utilities - * onto the manifold along a direction which is an estimation of the - * surrounding points (hence mesh cell) normal. - * - * The direction normal to the mesh is particularly useful because it is the - * direction in which the mesh is missing nodes. For instance, during the - * refinement of a cell a new node is initially created around the - * baricenter of the cell. This location somehow ensures a uniform distance - * from the nodes of the old cell. Projecting such cell baricenter onto the - * CAD surface in the direction normal to the original cell will then retain - * uniform distance from the points of the original cell. Of course, at the - * stage of mesh generation, no dof handler nor finite element are defined, - * and such direction has to be estimated. For the case in which 8 - * surrounding points are present, 4 different triangles are identified with - * the points assigned, and the normals of such triangles are averaged to - * obtain the approximation of the normal to the cell. - * - * The case in which 2 surrounding points are present (i.e.:a cell edge is - * being refined) is of course more tricky. The average of the CAD surface - * normals at the 2 surrounding points is first computed, and then projected - * onto the plane normal to the segment linking the surrounding points. This - * again is an attempt to have the new point with equal distance with - * respect to the surrounding points - * - * This class only operates with CAD faces and makes the assumption that the - * shape you pass to it contains at least one face. If that is not the case, - * an Exception is thrown. In debug mode there is a sanity check to make - * sure that the surrounding points (the ones used in project_to_manifold()) - * actually live on the Manifold, i.e., calling OpenCASCADE::closest_point() - * on those points leaves them untouched. If this is not the case, an - * ExcPointNotOnManifold is thrown. - * - * - * Notice that this type of Manifold descriptor may fail to give results if - * the triangulation to be refined is close to the boundary of the given - * TopoDS_Shape, or when the normal direction estimated from the surrounding - * points does not intersect the shape. An exception is thrown when this - * happens. - * - * - * @deprecated Use NormalToMeshProjectionManifold instead, which is identical to - * this class but satisfies the modern Manifold-based naming convention. - */ - template - class DEAL_II_DEPRECATED NormalToMeshProjectionBoundary - : public NormalToMeshProjectionManifold - { - public: - /** - * Inherit all constructors. - */ - using NormalToMeshProjectionManifold:: - NormalToMeshProjectionManifold; - - /** - * Clone the current Manifold. - */ - virtual std::unique_ptr> - clone() const override; - }; -} // namespace OpenCASCADE - -/*@}*/ - -DEAL_II_NAMESPACE_CLOSE - - -# endif // DEAL_II_WITH_OPENCASCADE - -#endif // dealii_occ_boundary_lib_h -/*---------------------------- occ_boundary_lib.h ---------------------------*/ diff --git a/source/opencascade/CMakeLists.txt b/source/opencascade/CMakeLists.txt index 2b4b7ab6a1..5958362390 100644 --- a/source/opencascade/CMakeLists.txt +++ b/source/opencascade/CMakeLists.txt @@ -17,12 +17,10 @@ INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR}) SET(_src utilities.cc - boundary_lib.cc manifold_lib.cc ) SET(_inst - boundary_lib.inst.in manifold_lib.inst.in utilities.inst.in ) diff --git a/source/opencascade/boundary_lib.cc b/source/opencascade/boundary_lib.cc deleted file mode 100644 index d18e92bead..0000000000 --- a/source/opencascade/boundary_lib.cc +++ /dev/null @@ -1,60 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2014 - 2018 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. -// -// --------------------------------------------------------------------- - - -#include - -#ifdef DEAL_II_WITH_OPENCASCADE - -DEAL_II_NAMESPACE_OPEN - -namespace OpenCASCADE -{ - template - std::unique_ptr> - NormalProjectionBoundary::clone() const - { - return std::unique_ptr>( - new NormalProjectionBoundary(this->sh, this->tolerance)); - } - - - - template - std::unique_ptr> - DirectionalProjectionBoundary::clone() const - { - return std::unique_ptr>( - new DirectionalProjectionBoundary(this->sh, - this->direction, - this->tolerance)); - } - - - - template - std::unique_ptr> - NormalToMeshProjectionBoundary::clone() const - { - return std::unique_ptr>( - new NormalToMeshProjectionBoundary(this->sh, this->tolerance)); - } -// Explicit instantiations -# include "boundary_lib.inst" -} // namespace OpenCASCADE - -DEAL_II_NAMESPACE_CLOSE - -#endif diff --git a/source/opencascade/boundary_lib.inst.in b/source/opencascade/boundary_lib.inst.in deleted file mode 100644 index 3650a145e7..0000000000 --- a/source/opencascade/boundary_lib.inst.in +++ /dev/null @@ -1,28 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2014 - 2020 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. -// -// --------------------------------------------------------------------- - - - -for (deal_II_dimension : DIMENSIONS) - { - template class NormalProjectionBoundary; - template class DirectionalProjectionBoundary; - template class NormalToMeshProjectionBoundary; -#if deal_II_dimension <= 2 - template class NormalProjectionBoundary; - template class DirectionalProjectionBoundary; - template class NormalToMeshProjectionBoundary; -#endif - } diff --git a/tests/fail/arclength_boundary_02.cc b/tests/fail/arclength_boundary_02.cc index 0fd4c2c83a..8a1e5542e0 100644 --- a/tests/fail/arclength_boundary_02.cc +++ b/tests/fail/arclength_boundary_02.cc @@ -18,7 +18,7 @@ #include #include -#include +#include #include #include diff --git a/tests/gmsh/create_tria_02.cc b/tests/gmsh/create_tria_02.cc index 8d50b6c8b1..bfeffa9b71 100644 --- a/tests/gmsh/create_tria_02.cc +++ b/tests/gmsh/create_tria_02.cc @@ -23,7 +23,7 @@ #include #include -#include +#include #include #include "../tests.h" diff --git a/tests/opencascade/arclength_boundary_01.cc b/tests/opencascade/arclength_boundary_01.cc index 8080aff2bb..ce4faf7bf3 100644 --- a/tests/opencascade/arclength_boundary_01.cc +++ b/tests/opencascade/arclength_boundary_01.cc @@ -18,7 +18,7 @@ #include #include -#include +#include #include #include diff --git a/tests/opencascade/arclength_boundary_from_iges_01.cc b/tests/opencascade/arclength_boundary_from_iges_01.cc index 7417b1c174..1b5e32a3b7 100644 --- a/tests/opencascade/arclength_boundary_from_iges_01.cc +++ b/tests/opencascade/arclength_boundary_from_iges_01.cc @@ -18,7 +18,7 @@ #include #include -#include +#include #include #include diff --git a/tests/opencascade/arclength_boundary_from_step_01.cc b/tests/opencascade/arclength_boundary_from_step_01.cc index 6ff05fc243..ae659ac19c 100644 --- a/tests/opencascade/arclength_boundary_from_step_01.cc +++ b/tests/opencascade/arclength_boundary_from_step_01.cc @@ -18,7 +18,7 @@ #include #include -#include +#include #include #include diff --git a/tests/opencascade/axis_boundary_02.cc b/tests/opencascade/axis_boundary_02.cc index 1f5f350a5e..1ba019966a 100644 --- a/tests/opencascade/axis_boundary_02.cc +++ b/tests/opencascade/axis_boundary_02.cc @@ -14,13 +14,13 @@ // --------------------------------------------------------------------- -// Test the class DirectionalProjectionBoundary +// Test the class DirectionalProjectionManifold #include #include #include -#include +#include #include #include @@ -53,7 +53,7 @@ main() TopoDS_Face face = BRepFill::Face(edge1, edge2); - DirectionalProjectionBoundary<2, 3> manifold(face, Point<3>(0, 0, 1)); + DirectionalProjectionManifold<2, 3> manifold(face, Point<3>(0, 0, 1)); Triangulation<2, 3> tria; GridGenerator::hyper_cube(tria); diff --git a/tests/opencascade/create_tria_00.cc b/tests/opencascade/create_tria_00.cc index be172e40fd..bf2962332a 100644 --- a/tests/opencascade/create_tria_00.cc +++ b/tests/opencascade/create_tria_00.cc @@ -24,7 +24,7 @@ #include #include -#include +#include #include #include diff --git a/tests/opencascade/create_tria_01.cc b/tests/opencascade/create_tria_01.cc index 33af22aba6..fc9286f957 100644 --- a/tests/opencascade/create_tria_01.cc +++ b/tests/opencascade/create_tria_01.cc @@ -25,7 +25,7 @@ #include #include -#include +#include #include #include @@ -57,7 +57,7 @@ main() extract_geometrical_shapes(sh, faces, edges, vertices); // Create a boundary projector on the first face. - NormalProjectionBoundary<2, 3> boundary(faces[0]); + NormalProjectionManifold<2, 3> boundary(faces[0]); // Create a Triangulation with a single cell Triangulation<2, 3> tria; diff --git a/tests/opencascade/create_tria_02.cc b/tests/opencascade/create_tria_02.cc index f631510914..acfed75915 100644 --- a/tests/opencascade/create_tria_02.cc +++ b/tests/opencascade/create_tria_02.cc @@ -19,7 +19,7 @@ #include -#include +#include #include #include diff --git a/tests/opencascade/directional_boundary_01.cc b/tests/opencascade/directional_boundary_01.cc index 7215fdd6d1..6819337ebb 100644 --- a/tests/opencascade/directional_boundary_01.cc +++ b/tests/opencascade/directional_boundary_01.cc @@ -20,7 +20,7 @@ #include #include -#include +#include #include #include @@ -54,7 +54,7 @@ main() TopoDS_Face face = BRepFill::Face(edge1, edge2); - DirectionalProjectionBoundary<1, 3> manifold(face, Point<3>(0, 1, 0)); + DirectionalProjectionManifold<1, 3> manifold(face, Point<3>(0, 1, 0)); Triangulation<1, 3> tria; GridGenerator::hyper_cube(tria); diff --git a/tests/opencascade/interpolation_curve_boundary.cc b/tests/opencascade/interpolation_curve_boundary.cc index f326ea273e..19bcbab15e 100644 --- a/tests/opencascade/interpolation_curve_boundary.cc +++ b/tests/opencascade/interpolation_curve_boundary.cc @@ -24,7 +24,7 @@ #include #include -#include +#include #include #include @@ -55,7 +55,7 @@ main() TopoDS_Shape shape = interpolation_curve(vertices, Point<3>(), true); // Create a boundary projector. - NormalProjectionBoundary<2, 3> boundary_line(shape); + NormalProjectionManifold<2, 3> boundary_line(shape); // The unit square. Triangulation<2, 3> tria; diff --git a/tests/opencascade/interpolation_curve_boundary_02.cc b/tests/opencascade/interpolation_curve_boundary_02.cc index c32c3a6106..02651b4472 100644 --- a/tests/opencascade/interpolation_curve_boundary_02.cc +++ b/tests/opencascade/interpolation_curve_boundary_02.cc @@ -25,7 +25,7 @@ #include #include -#include +#include #include #include diff --git a/tests/opencascade/manifold_clone_01.cc b/tests/opencascade/manifold_clone_01.cc index ae70964d82..90389b8153 100644 --- a/tests/opencascade/manifold_clone_01.cc +++ b/tests/opencascade/manifold_clone_01.cc @@ -17,7 +17,6 @@ // checks that the renamed manifolds are not just aliases but, when cloned, // give the correct object type. -#include #include #include @@ -53,12 +52,6 @@ main() Handle(Geom_Circle) circle = make_circle.Value(); TopoDS_Edge edge = BRepBuilderAPI_MakeEdge(circle); - NormalProjectionBoundary<2, 3> manifold_b(edge); - std::unique_ptr> clone_b = manifold_b.clone(); - const auto & deref_clone_b = *clone_b; - deallog << "typeid of NormalProjectionBoundary<2, 3> is " - << boost::core::demangle(typeid(deref_clone_b).name()) << std::endl; - NormalProjectionManifold<2, 3> manifold_m(edge); std::unique_ptr> clone_m = manifold_m.clone(); const auto & deref_clone_m = *clone_m; @@ -81,17 +74,9 @@ main() TopoDS_Face face = BRepFill::Face(edge1, edge2); - DirectionalProjectionBoundary<2, 3> manifold_b(face, Point<3>(0, 0, 1)); - - std::unique_ptr> clone_b = manifold_b.clone(); - const auto & deref_clone_b = *clone_b; - deallog << "typeid of DirectionalProjectionBoundary<2, 3> is " - << boost::core::demangle(typeid(deref_clone_b).name()) << std::endl; - DirectionalProjectionManifold<2, 3> manifold_m(face, Point<3>(0, 0, 1)); - - std::unique_ptr> clone_m = manifold_m.clone(); - const auto & deref_clone_m = *clone_m; + std::unique_ptr> clone_m = manifold_m.clone(); + const auto & deref_clone_m = *clone_m; deallog << "typeid of DirectionalProjectionManifold<2, 3> is " << boost::core::demangle(typeid(deref_clone_m).name()) << std::endl; } @@ -111,13 +96,6 @@ main() TopoDS_Face face = BRepFill::Face(edge1, edge2); - NormalToMeshProjectionBoundary<1, 3> manifold_b(face); - - std::unique_ptr> clone_b = manifold_b.clone(); - const auto & deref_clone_b = *clone_b; - deallog << "typeid of NormalProjectionBoundary<2, 3> is " - << boost::core::demangle(typeid(deref_clone_b).name()) << std::endl; - NormalToMeshProjectionManifold<1, 3> manifold_m(face); std::unique_ptr> clone_m = manifold_m.clone(); const auto & deref_clone_m = *clone_m; diff --git a/tests/opencascade/manifold_clone_01.output b/tests/opencascade/manifold_clone_01.output index 7dc30c22a5..f5b2106d35 100644 --- a/tests/opencascade/manifold_clone_01.output +++ b/tests/opencascade/manifold_clone_01.output @@ -1,8 +1,5 @@ -DEAL::typeid of NormalProjectionBoundary<2, 3> is dealii::OpenCASCADE::NormalProjectionBoundary<2, 3> DEAL::typeid of NormalProjectionManifold<2, 3> is dealii::OpenCASCADE::NormalProjectionManifold<2, 3> -DEAL::typeid of DirectionalProjectionBoundary<2, 3> is dealii::OpenCASCADE::DirectionalProjectionBoundary<2, 3> DEAL::typeid of DirectionalProjectionManifold<2, 3> is dealii::OpenCASCADE::DirectionalProjectionManifold<2, 3> -DEAL::typeid of NormalProjectionBoundary<2, 3> is dealii::OpenCASCADE::NormalToMeshProjectionBoundary<1, 3> DEAL::typeid of NormalProjectionManifold<2, 3> is dealii::OpenCASCADE::NormalToMeshProjectionManifold<1, 3> DEAL::OK diff --git a/tests/opencascade/normal_projection_01.cc b/tests/opencascade/normal_projection_01.cc index 4daa04fa86..822fe21b93 100644 --- a/tests/opencascade/normal_projection_01.cc +++ b/tests/opencascade/normal_projection_01.cc @@ -24,7 +24,7 @@ #include #include -#include +#include #include #include @@ -54,7 +54,7 @@ main() TopoDS_Face face = BRepPrimAPI_MakeSphere(center, radius); // Create a boundary projector. - NormalProjectionBoundary<3, 3> sphere(face); + NormalProjectionManifold<3, 3> sphere(face); // The unit cube. diff --git a/tests/opencascade/normal_to_mesh_projection_01.cc b/tests/opencascade/normal_to_mesh_projection_01.cc index 37a1b00aac..a66de2dc70 100644 --- a/tests/opencascade/normal_to_mesh_projection_01.cc +++ b/tests/opencascade/normal_to_mesh_projection_01.cc @@ -20,7 +20,7 @@ #include #include -#include +#include #include #include @@ -54,7 +54,7 @@ main() TopoDS_Face face = BRepFill::Face(edge1, edge2); - NormalToMeshProjectionBoundary<1, 3> manifold(face); + NormalToMeshProjectionManifold<1, 3> manifold(face); Triangulation<1, 3> tria; GridGenerator::hyper_cube(tria); diff --git a/tests/opencascade/normal_to_mesh_projection_02.cc b/tests/opencascade/normal_to_mesh_projection_02.cc index 59fd591aaa..e22c65cc3a 100644 --- a/tests/opencascade/normal_to_mesh_projection_02.cc +++ b/tests/opencascade/normal_to_mesh_projection_02.cc @@ -20,7 +20,7 @@ #include #include -#include +#include #include #include @@ -54,7 +54,7 @@ main() TopoDS_Face face = BRepFill::Face(edge1, edge2); - NormalToMeshProjectionBoundary<2, 3> manifold(face); + NormalToMeshProjectionManifold<2, 3> manifold(face); Triangulation<2, 3> tria; GridGenerator::hyper_cube(tria); diff --git a/tests/opencascade/normal_to_mesh_projection_03.cc b/tests/opencascade/normal_to_mesh_projection_03.cc index 275039410e..30de03d123 100644 --- a/tests/opencascade/normal_to_mesh_projection_03.cc +++ b/tests/opencascade/normal_to_mesh_projection_03.cc @@ -28,7 +28,7 @@ #include #include -#include +#include #include #include @@ -62,7 +62,7 @@ main() TopoDS_Face face = BRepFill::Face(edge1, edge2); - NormalToMeshProjectionBoundary<2, 3> manifold(face); + NormalToMeshProjectionManifold<2, 3> manifold(face); Triangulation<2, 3> tria; GridGenerator::hyper_cube(tria); diff --git a/tests/opencascade/nurbs_patches_manifold_00.cc b/tests/opencascade/nurbs_patches_manifold_00.cc index 571175f7b2..f5ea6475bd 100644 --- a/tests/opencascade/nurbs_patches_manifold_00.cc +++ b/tests/opencascade/nurbs_patches_manifold_00.cc @@ -17,7 +17,7 @@ // Read goteborg.iges and dump its topological structure to the // logfile. -#include +#include #include #include diff --git a/tests/opencascade/project_center_cell_01.cc b/tests/opencascade/project_center_cell_01.cc index ae158fed4f..37cdc0e2cc 100644 --- a/tests/opencascade/project_center_cell_01.cc +++ b/tests/opencascade/project_center_cell_01.cc @@ -25,7 +25,7 @@ #include #include -#include +#include #include #include @@ -58,7 +58,7 @@ main() // Create a boundary projector on the first face. - NormalProjectionBoundary<2, 3> boundary(faces[0]); + NormalProjectionManifold<2, 3> boundary(faces[0]); // Create a Triangulation with a single cell Triangulation<2, 3> tria; -- 2.39.5