]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated OpenCASCADE classes
authorDaniel Arndt <arndtd@ornl.gov>
Fri, 5 Jun 2020 21:02:31 +0000 (17:02 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Mon, 22 Jun 2020 02:41:43 +0000 (22:41 -0400)
24 files changed:
include/deal.II/opencascade/boundary_lib.h [deleted file]
source/opencascade/CMakeLists.txt
source/opencascade/boundary_lib.cc [deleted file]
source/opencascade/boundary_lib.inst.in [deleted file]
tests/fail/arclength_boundary_02.cc
tests/gmsh/create_tria_02.cc
tests/opencascade/arclength_boundary_01.cc
tests/opencascade/arclength_boundary_from_iges_01.cc
tests/opencascade/arclength_boundary_from_step_01.cc
tests/opencascade/axis_boundary_02.cc
tests/opencascade/create_tria_00.cc
tests/opencascade/create_tria_01.cc
tests/opencascade/create_tria_02.cc
tests/opencascade/directional_boundary_01.cc
tests/opencascade/interpolation_curve_boundary.cc
tests/opencascade/interpolation_curve_boundary_02.cc
tests/opencascade/manifold_clone_01.cc
tests/opencascade/manifold_clone_01.output
tests/opencascade/normal_projection_01.cc
tests/opencascade/normal_to_mesh_projection_01.cc
tests/opencascade/normal_to_mesh_projection_02.cc
tests/opencascade/normal_to_mesh_projection_03.cc
tests/opencascade/nurbs_patches_manifold_00.cc
tests/opencascade/project_center_cell_01.cc

diff --git a/include/deal.II/opencascade/boundary_lib.h b/include/deal.II/opencascade/boundary_lib.h
deleted file mode 100644 (file)
index 230af95..0000000
+++ /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 <deal.II/base/config.h>
-
-#  ifdef DEAL_II_WITH_OPENCASCADE
-
-#    include <deal.II/opencascade/manifold_lib.h>
-
-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 <int dim, int spacedim>
-  class DEAL_II_DEPRECATED NormalProjectionBoundary
-    : public NormalProjectionManifold<dim, spacedim>
-  {
-  public:
-    /**
-     * Inherit all constructors.
-     */
-    using NormalProjectionManifold<dim, spacedim>::NormalProjectionManifold;
-
-    /**
-     * Clone the current Manifold.
-     */
-    virtual std::unique_ptr<Manifold<dim, spacedim>>
-    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 <int dim, int spacedim>
-  class DEAL_II_DEPRECATED DirectionalProjectionBoundary
-    : public DirectionalProjectionManifold<dim, spacedim>
-  {
-  public:
-    /**
-     * Inherit all constructors.
-     */
-    using DirectionalProjectionManifold<dim, spacedim>::
-      DirectionalProjectionManifold;
-
-    /**
-     * Clone the current Manifold.
-     */
-    virtual std::unique_ptr<Manifold<dim, spacedim>>
-    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 <int dim, int spacedim>
-  class DEAL_II_DEPRECATED NormalToMeshProjectionBoundary
-    : public NormalToMeshProjectionManifold<dim, spacedim>
-  {
-  public:
-    /**
-     * Inherit all constructors.
-     */
-    using NormalToMeshProjectionManifold<dim, spacedim>::
-      NormalToMeshProjectionManifold;
-
-    /**
-     * Clone the current Manifold.
-     */
-    virtual std::unique_ptr<Manifold<dim, spacedim>>
-    clone() const override;
-  };
-} // namespace OpenCASCADE
-
-/*@}*/
-
-DEAL_II_NAMESPACE_CLOSE
-
-
-#  endif // DEAL_II_WITH_OPENCASCADE
-
-#endif // dealii_occ_boundary_lib_h
-/*---------------------------- occ_boundary_lib.h ---------------------------*/
index 2b4b7ab6a12b3594c4e9c4ca65912e85fdea55f6..5958362390b98357ee5f7f9b4b5547282c2a5735 100644 (file)
@@ -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 (file)
index d18e92b..0000000
+++ /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 <deal.II/opencascade/boundary_lib.h>
-
-#ifdef DEAL_II_WITH_OPENCASCADE
-
-DEAL_II_NAMESPACE_OPEN
-
-namespace OpenCASCADE
-{
-  template <int dim, int spacedim>
-  std::unique_ptr<Manifold<dim, spacedim>>
-  NormalProjectionBoundary<dim, spacedim>::clone() const
-  {
-    return std::unique_ptr<Manifold<dim, spacedim>>(
-      new NormalProjectionBoundary(this->sh, this->tolerance));
-  }
-
-
-
-  template <int dim, int spacedim>
-  std::unique_ptr<Manifold<dim, spacedim>>
-  DirectionalProjectionBoundary<dim, spacedim>::clone() const
-  {
-    return std::unique_ptr<Manifold<dim, spacedim>>(
-      new DirectionalProjectionBoundary(this->sh,
-                                        this->direction,
-                                        this->tolerance));
-  }
-
-
-
-  template <int dim, int spacedim>
-  std::unique_ptr<Manifold<dim, spacedim>>
-  NormalToMeshProjectionBoundary<dim, spacedim>::clone() const
-  {
-    return std::unique_ptr<Manifold<dim, spacedim>>(
-      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 (file)
index 3650a14..0000000
+++ /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<deal_II_dimension, 3>;
-    template class DirectionalProjectionBoundary<deal_II_dimension, 3>;
-    template class NormalToMeshProjectionBoundary<deal_II_dimension, 3>;
-#if deal_II_dimension <= 2
-    template class NormalProjectionBoundary<deal_II_dimension, 2>;
-    template class DirectionalProjectionBoundary<deal_II_dimension, 2>;
-    template class NormalToMeshProjectionBoundary<deal_II_dimension, 2>;
-#endif
-  }
index 0fd4c2c83a2982e6a9ab21c4756b5b1f31b978b1..8a1e5542e02d4d05d3a69ee7db940da8af1fb696 100644 (file)
@@ -18,7 +18,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <Standard_Stream.hxx>
index 8d50b6c8b17aa00d607e54aacc69b590da117a13..bfeffa9b71cecebe7f9f503541b3ff012bf8f82c 100644 (file)
@@ -23,7 +23,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include "../tests.h"
index 8080aff2bbbef9803160121e48a1f3ca9ea6d80b..ce4faf7bf358d5146a5ee0fde5445b98e69ec6d5 100644 (file)
@@ -18,7 +18,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <Standard_Stream.hxx>
index 7417b1c174fea4c44dc39b06a2fcee6ba59b119a..1b5e32a3b76250fa763619580fcb94235ccd2222 100644 (file)
@@ -18,7 +18,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <Standard_Stream.hxx>
index 6ff05fc24320c79df901d86c49fe2dd8bd72769e..ae659ac19cf56e282f160bc3fb5f6bdc6e60345a 100644 (file)
@@ -18,7 +18,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <Standard_Stream.hxx>
index 1f5f350a5e8b11df39e1abefaea02fc8674597e5..1ba019966ac94d320cad0cd7f25f591888b7cccc 100644 (file)
 // ---------------------------------------------------------------------
 
 
-// Test the class DirectionalProjectionBoundary
+// Test the class DirectionalProjectionManifold
 
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <BRepFill.hxx>
@@ -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);
index be172e40fd4ba500c359fe8fc6f6d7fabdafe962..bf2962332a345d177dcb7d3d5fcce64d699f2e24 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 
 #include <BRepBuilderAPI_MakeEdge.hxx>
 #include <BRepBuilderAPI_MakeFace.hxx>
index 33af22aba600bc6e59a0209ad0459acfa8e53961..fc9286f95739a62d6abe5dac0119429bb9d43b52 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 
 #include <BRepBuilderAPI_MakeEdge.hxx>
 #include <BRepBuilderAPI_MakeFace.hxx>
@@ -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;
index f631510914a67150eb2fd01b279963b25fd5339f..acfed75915615ae053a07fe4c5c6ff43720c1ee0 100644 (file)
@@ -19,7 +19,7 @@
 
 #include <deal.II/grid/grid_out.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <BRepPrimAPI_MakeRevol.hxx>
index 7215fdd6d174fbbba522923a7edf1a15125fe6f1..6819337ebb516e3664f38a8ea0a172bc0a87503b 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <BRepFill.hxx>
@@ -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);
index f326ea273e10b7f5e026a6376d8e89b1356af7b3..19bcbab15e16b06571902f877391aa9d848c7f0c 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 
 #include <BRepBuilderAPI_MakeEdge.hxx>
 #include <BRepBuilderAPI_MakeFace.hxx>
@@ -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;
index c32c3a61067e15835dedf661272cfb9d8eb44ef9..02651b447201984dec069b84e3085a0ecaccfce9 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 
 #include <BRepBuilderAPI_MakeEdge.hxx>
 #include <BRepBuilderAPI_MakeFace.hxx>
index ae70964d823a4e4b7b8c99067dbc0e0e39a06c40..90389b8153675f0f3a58fec1f94881541d43a7ab 100644 (file)
@@ -17,7 +17,6 @@
 // checks that the renamed manifolds are not just aliases but, when cloned,
 // give the correct object type.
 
-#include <deal.II/opencascade/boundary_lib.h>
 #include <deal.II/opencascade/manifold_lib.h>
 
 #include <boost/core/demangle.hpp>
@@ -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<Manifold<2, 3>> 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<Manifold<2, 3>> 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<Manifold<2, 3>> 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<Manifold<2, 3>> clone_m       = manifold_m.clone();
-    const auto &                    deref_clone_m = *clone_m;
+    std::unique_ptr<Manifold<2, 3>>     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<Manifold<1, 3>> 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<Manifold<1, 3>>      clone_m       = manifold_m.clone();
     const auto &                         deref_clone_m = *clone_m;
index 7dc30c22a57bec31f399bb23665bbd50e1257205..f5b2106d3519343d86960f6a83950556a2eb546f 100644 (file)
@@ -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
index 4daa04fa86749c3c44b90e36e8127772c870e913..822fe21b938b5fb556d63cd1b5247cd39df26496 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 
 #include <BRepBuilderAPI_MakeEdge.hxx>
 #include <BRepBuilderAPI_MakeFace.hxx>
@@ -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.
index 37a1b00aac03309ec37b52d33ce3012d7524c0b4..a66de2dc7048b5638750f3f3ef2f4ceb2d62ba3d 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <BRepFill.hxx>
@@ -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);
index 59fd591aaa3fa4e3b55b9c83fa9a0dae5f50fdd4..e22c65cc3a36de717e40a493085641a2df204d53 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <BRepFill.hxx>
@@ -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);
index 275039410e715eddcccb01ea9b14fe92042c2c86..30de03d123b65e9cbf8bc4a905979bb8691e8607 100644 (file)
@@ -28,7 +28,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <BRepFill.hxx>
@@ -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);
index 571175f7b2d963d60d69ef538a521ea41c766a59..f5ea6475bd06da75da7a57e87139bc1dc0aa0311 100644 (file)
@@ -17,7 +17,7 @@
 // Read goteborg.iges and dump its topological structure to the
 // logfile.
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 #include <deal.II/opencascade/utilities.h>
 
 #include <Standard_Stream.hxx>
index ae158fed4fc567c345f3ddfbcbe3a379266d011d..37cdc0e2cc77468776ac480ca8490751276b698b 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/opencascade/boundary_lib.h>
+#include <deal.II/opencascade/manifold_lib.h>
 
 #include <BRepBuilderAPI_MakeEdge.hxx>
 #include <BRepBuilderAPI_MakeFace.hxx>
@@ -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;

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.