]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Reverted all changes made to the examples directory, so that they are identical to...
authorheltai <heltai@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 15 Jan 2014 09:38:11 +0000 (09:38 +0000)
committerheltai <heltai@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 15 Jan 2014 09:38:11 +0000 (09:38 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_manifold_id@32216 0785d39b-7218-0410-832d-ea1e28bc413d

27 files changed:
deal.II/examples/step-1/step-1.cc
deal.II/examples/step-10/step-10.cc
deal.II/examples/step-11/step-11.cc
deal.II/examples/step-15/step-15.cc
deal.II/examples/step-16/step-16.cc
deal.II/examples/step-17/step-17.cc
deal.II/examples/step-18/step-18.cc
deal.II/examples/step-2/step-2.cc
deal.II/examples/step-22/step-22.cc
deal.II/examples/step-24/step-24.cc
deal.II/examples/step-28/step-28.cc
deal.II/examples/step-29/step-29.cc
deal.II/examples/step-32/step-32.cc
deal.II/examples/step-34/step-34.cc
deal.II/examples/step-35/step-35.cc
deal.II/examples/step-37/step-37.cc
deal.II/examples/step-38/step-38.cc
deal.II/examples/step-42/step-42.cc
deal.II/examples/step-44/step-44.cc
deal.II/examples/step-49/step-49.cc
deal.II/examples/step-5/step-5.cc
deal.II/examples/step-50/step-50.cc
deal.II/examples/step-51/step-51.cc
deal.II/examples/step-6/step-6.cc
deal.II/examples/step-7/step-7.cc
deal.II/examples/step-8/step-8.cc
deal.II/examples/step-9/step-9.cc

index 5d1e1ea9715eb7b690e20a82f46b3f411e7f43a0..96da272b2b7164633794c1664510b353897dd1a4 100644 (file)
@@ -1,18 +1,20 @@
-// ---------------------------------------------------------------------
-// $Id$
-//
-// Copyright (C) 1999 - 2013 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 at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
+/* ---------------------------------------------------------------------
+ * $Id$
+ *
+ * Copyright (C) 1999 - 2013 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 at
+ * the top level of the deal.II distribution.
+ *
+ * ---------------------------------------------------------------------
+
+ */
 
 // @sect3{Include files}
 
@@ -90,7 +92,7 @@ void second_grid ()
   // We then fill it with a ring domain. The center of the ring shall be the
   // point (1,0), and inner and outer radius shall be 0.5 and 1. The number of
   // circumferential cells could be adjusted automatically by this function,
-  // but we choose to set it explicitely to 10 as the last argument:
+  // but we choose to set it explicitly to 10 as the last argument:
   const Point<2> center (1,0);
   const double inner_radius = 0.5,
                outer_radius = 1.0;
@@ -122,12 +124,10 @@ void second_grid ()
   // @ref GlossBoundaryIndicator "glossary entry on this topic".)
   const HyperShellBoundary<2> boundary_description(center);
   triangulation.set_boundary (0, boundary_description);
-  triangulation.refine_global(1);
-  
 
   // In order to demonstrate how to write a loop over all cells, we will
   // refine the grid in five steps towards the inner circle of the domain:
-  for (unsigned int step=0; step<0; ++step)
+  for (unsigned int step=0; step<5; ++step)
     {
       // Next, we need an iterator which points to a cell and which we will
       // move over all active cells one by one (active cells are those that
index 17838b3c763856e2d37698625e79c19f0f37956c..90c70d633be75d1cfce74ab3d5ed4aa3c77b0f62 100644 (file)
@@ -26,7 +26,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/dofs/dof_handler.h>
@@ -82,8 +82,8 @@ namespace Step10
     // radius equals one.
     Triangulation<dim> triangulation;
     GridGenerator::hyper_ball (triangulation);
-    static const PolarManifold<dim> boundary;
-    triangulation.set_manifold (0, boundary);
+    static const HyperBallBoundary<dim> boundary;
+    triangulation.set_boundary (0, boundary);
 
     // Next generate output for this grid and for a once refined grid. Note
     // that we have hidden the mesh refinement in the loop header, which might
@@ -216,8 +216,8 @@ namespace Step10
         Triangulation<dim> triangulation;
         GridGenerator::hyper_ball (triangulation);
 
-        static const PolarManifold<dim> boundary;
-        triangulation.set_manifold (0, boundary);
+        static const HyperBallBoundary<dim> boundary;
+        triangulation.set_boundary (0, boundary);
 
         const MappingQ<dim> mapping (degree);
 
@@ -352,8 +352,8 @@ namespace Step10
         Triangulation<dim> triangulation;
         GridGenerator::hyper_ball (triangulation);
 
-        static const PolarManifold<dim> boundary;
-        triangulation.set_manifold (0, boundary);
+        static const HyperBallBoundary<dim> boundary;
+        triangulation.set_boundary (0, boundary);
 
         const MappingQ<dim> mapping (degree);
         const FE_Q<dim>     fe (1);
index 223219e3a77295c8ac9e999ce2f4c73157e4bb02..c5b22763900810e782805bd0d161edd2d58e59a0 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/constraint_matrix.h>
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/dofs/dof_handler.h>
@@ -414,8 +414,8 @@ namespace Step11
   void LaplaceProblem<dim>::run ()
   {
     GridGenerator::hyper_ball (triangulation);
-    static const PolarManifold<dim> boundary;
-    triangulation.set_manifold (0, boundary);
+    static const HyperBallBoundary<dim> boundary;
+    triangulation.set_boundary (0, boundary);
 
     for (unsigned int cycle=0; cycle<6; ++cycle, triangulation.refine_global(1))
       {
index 6dcc5c4c2483a5642bfe4eac3394e7c45557faec..02ae8914e616aa6d0448d56c0df2374d72c0c00e 100644 (file)
@@ -40,7 +40,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/grid_refinement.h>
 
 #include <deal.II/dofs/dof_handler.h>
@@ -628,8 +628,8 @@ namespace Step15
     // the origin, created in the same way as shown in step-6. The mesh is
     // globally refined twice followed later on by several adaptive cycles:
     GridGenerator::hyper_ball (triangulation);
-    static const PolarManifold<dim> boundary;
-    triangulation.set_manifold (0, boundary);
+    static const HyperBallBoundary<dim> boundary;
+    triangulation.set_boundary (0, boundary);
     triangulation.refine_global(2);
 
     // The Newton iteration starts next. During the first step we do not have
index 33ddf4d578f85c1392c9c1fa8817f38e2a81b3d6..e03e244297f97fd5fa9121026a40208c77ad76b7 100644 (file)
@@ -50,7 +50,7 @@
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_refinement.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
@@ -768,8 +768,8 @@ namespace Step16
           {
             GridGenerator::hyper_ball (triangulation);
 
-            static const PolarManifold<dim> boundary;
-            triangulation.set_manifold (0, boundary);
+            static const HyperBallBoundary<dim> boundary;
+            triangulation.set_boundary (0, boundary);
 
             triangulation.refine_global (1);
           }
index 77306f52cc6b39737e767ef2b07140e51eae918d..9f072eea3519c73d66fb3b0d3c7e854a1404b79d 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/grid/grid_refinement.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index 6d9cf380397de7ae573a72e973f9ce4cfdf39f1d..ff5f5bb61928b9f4efe1316366305af6bd591d0e 100644 (file)
@@ -1738,6 +1738,17 @@ namespace Step18
   // to the vertex we consider at present, as they may or may not be ordered
   // in the same order.
   //
+  // This inconvenience could be avoided if finite elements have support
+  // points on vertices (which the one here has; for the concept of support
+  // points, see @ref GlossSupport "support points"). For such a case, one
+  // could construct a custom quadrature rule using
+  // FiniteElement::get_unit_support_points(). The first
+  // <code>GeometryInfo@<dim@>::vertices_per_cell*fe.dofs_per_vertex</code>
+  // quadrature points will then correspond to the vertices of the cell and
+  // are ordered consistent with <code>cell-@>vertex(i)</code>, taking into
+  // account that support points for vector elements will be duplicated
+  // <code>fe.dofs_per_vertex</code> times.
+  //
   // Another point worth explaining about this short function is the way in
   // which the triangulation class exports information about its vertices:
   // through the <code>Triangulation::n_vertices</code> function, it
index fed915ca51a11ca565269ff3ceab299efca6f7cf..b3c9d2debbd059d12cd19ef2dc62d1df47733504 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 // However, the next file is new. We need this include file for the
 // association of degrees of freedom ("DoF"s) to vertices, lines, and cells:
@@ -88,8 +88,8 @@ void make_grid (Triangulation<2> &triangulation)
                               center, inner_radius, outer_radius,
                               10);
 
-  static const PolarManifold<2> boundary_description(center);
-  triangulation.set_manifold (0, boundary_description);
+  static const HyperShellBoundary<2> boundary_description(center);
+  triangulation.set_boundary (0, boundary_description);
 
   for (unsigned int step=0; step<5; ++step)
     {
index ee118bbb5c66d658516733b63f3b8eeae42c37fe..e63bae370c368c42012fdf97ede42219441e1e0c 100644 (file)
@@ -38,7 +38,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_refinement.h>
 
index f711c4e6784faa8d1ec646c069d121ae8820a79a..e44ea21f12a1f3a86eae012abbf38940552e021f 100644 (file)
@@ -38,7 +38,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
@@ -271,8 +271,8 @@ namespace Step24
   {
     const Point<dim> center;
     GridGenerator::hyper_ball (triangulation, center, 1.);
-    static const PolarManifold<dim> boundary_description (center);
-    triangulation.set_manifold (0,boundary_description);
+    static const HyperBallBoundary<dim> boundary_description (center, 1.);
+    triangulation.set_boundary (0,boundary_description);
     triangulation.refine_global (7);
 
     time_step = GridTools::minimal_cell_diameter(triangulation) /
index d2d542941f4b8a344a63c9b78b280c9ae426fa0a..5e108c3b193927d5e453b68ade0e222177ea17f7 100644 (file)
@@ -42,7 +42,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index e581ff9685b8bffdedfd786afdc6ef725c04ecad..de6f652035562ab4bb4be20d35b676f615c51f2c 100644 (file)
@@ -36,7 +36,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
@@ -500,8 +500,8 @@ namespace Step29
     // program and thereby longer than the triangulation object we will
     // associated with it. We then assign this boundary-object to the part of
     // the boundary with boundary indicator 1:
-    static const PolarManifold<dim> boundary(focal_point);
-    triangulation.set_manifold (1, boundary);
+    static const HyperBallBoundary<dim> boundary(focal_point, radius);
+    triangulation.set_boundary(1, boundary);
 
     // Now global refinement is executed. Cells near the transducer location
     // will be automatically refined according to the circle shaped boundary
index 27e895b355a3a8468fcf5d61f6a66b6cf8a7c52c..cd2207025fb5159f235273eafa53fa15563bf624 100644 (file)
@@ -51,7 +51,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/grid/filtered_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_refinement.h>
 
@@ -3527,9 +3527,9 @@ namespace Step32
                                 EquationData::R1,
                                 (dim==3) ? 96 : 12,
                                 true);
-    static PolarManifold<dim> boundary;
-    triangulation.set_manifold (0, boundary);
-    triangulation.set_manifold (1, boundary);
+    static HyperShellBoundary<dim> boundary;
+    triangulation.set_boundary (0, boundary);
+    triangulation.set_boundary (1, boundary);
 
     global_Omega_diameter = GridTools::diameter (triangulation);
 
index af97f9503857695ab64580f27cf702397bbf5904..f675772db7f6c6494bc56f0a568365bb12a954d1 100644 (file)
@@ -43,7 +43,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_in.h>
 #include <deal.II/grid/grid_out.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
@@ -184,7 +184,7 @@ namespace Step34
     //
     // Experimenting a little with the computation of the angles gives very
     // accurate results for simpler geometries. To verify this you can comment
-    // out, in the read_domain() method, the tria.set_manifold (1, boundary)
+    // out, in the read_domain() method, the tria.set_boundary(1, boundary)
     // line, and check the alpha that is generated by the program. By removing
     // this call, whenever the mesh is refined new nodes will be placed along
     // the straight lines that made up the coarse mesh, rather than be pulled
@@ -496,7 +496,7 @@ namespace Step34
   void BEMProblem<dim>::read_domain()
   {
     static const Point<dim> center = Point<dim>();
-    static const PolarManifold<dim> boundary(center);
+    static const HyperBallBoundary<dim-1, dim> boundary(center,1.);
 
     std::ifstream in;
     switch (dim)
@@ -517,7 +517,7 @@ namespace Step34
     gi.attach_triangulation (tria);
     gi.read_ucd (in);
 
-    tria.set_manifold (1, boundary);
+    tria.set_boundary(1, boundary);
   }
 
 
index 61a93f8ee51a63cee8407e75e0a32dda704aa324..cd9d97906e797daeef66a3bfbae4a7a2621e849c 100644 (file)
@@ -49,7 +49,7 @@
 #include <deal.II/grid/grid_refinement.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/grid_in.h>
 
 #include <deal.II/dofs/dof_handler.h>
index a4a3a9ca88e1baf33997f5751e9f7747434b9103..9cf1b00a84537b230e8394a9c74b3969437a4fbc 100644 (file)
@@ -36,7 +36,7 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/grid_generator.h>
 
 #include <deal.II/multigrid/multigrid.h>
index 00ca34117a9f38f9d6f471ba83aa38b7f88ff382..a88ebe386556bdcd8b935371b116cca6bd47440c 100644 (file)
@@ -29,7 +29,7 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/lac/full_matrix.h>
@@ -318,8 +318,8 @@ namespace Step38
   template <int spacedim>
   void LaplaceBeltramiProblem<spacedim>::make_grid_and_dofs ()
   {
-    static PolarManifold<spacedim> surface_description;
-    triangulation.set_manifold (0, surface_description);
+    static HyperBallBoundary<dim,spacedim> surface_description;
+    triangulation.set_boundary (0, surface_description);
 
     {
       Triangulation<spacedim> volume_mesh;
index 75e4100b8625cc7a9bf9c9e41087393bd4174c7d..64cd41d3be9e56883da965788c511847eadfa53e 100644 (file)
@@ -51,7 +51,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 #include <deal.II/distributed/tria.h>
 #include <deal.II/distributed/grid_refinement.h>
@@ -912,8 +912,8 @@ namespace Step42
         GridTools::transform(&rotate_half_sphere, triangulation);
         GridTools::shift(Point<dim>(0.5, 0.5, 0.5), triangulation);
 
-        static PolarManifold<dim> boundary_description(Point<dim>(0.5, 0.5, 0.5));
-        triangulation.set_manifold(0, boundary_description);
+        static HyperBallBoundary<dim> boundary_description(Point<dim>(0.5, 0.5, 0.5), radius);
+        triangulation.set_boundary(0, boundary_description);
       }
     // Alternatively, create a hypercube mesh. After creating it,
     // assign boundary indicators as follows:
index f7b59a2f17bc2a7f8070ea8cd1bde5e6d3b76cac..80413f114f029a208eaa16b1645cff17d8a97cb6 100644 (file)
@@ -40,7 +40,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_in.h>
 #include <deal.II/grid/tria.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 #include <deal.II/fe/fe_dgp_monomial.h>
 #include <deal.II/fe/fe_q.h>
index a7f36f260da2894cba8ba463e3185c0e38745a50..a1139eb765b14f070a2d4dfcf5f894184c99de68 100644 (file)
@@ -34,7 +34,7 @@
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_tools.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/grid_in.h>
 
@@ -194,8 +194,8 @@ void grid_3 ()
   // an object that describes a circle (i.e., a hyper ball) with appropriate
   // center and radius and assign it to the triangulation. We can then refine
   // twice:
-  const  PolarManifold<2> boundary_description(Point<2>(0,0));
-  triangulation.set_manifold (1, boundary_description);
+  const HyperBallBoundary<2> boundary_description(Point<2>(0,0), 0.25);
+  triangulation.set_boundary (1, boundary_description);
   triangulation.refine_global(2);
 
   // The mesh so generated is then passed to the function that generates
@@ -204,7 +204,7 @@ void grid_3 ()
   // object is destroyed first in this function since it was declared after
   // the triangulation).
   mesh_info (triangulation, "grid-3.eps");
-  triangulation.set_manifold (1);
+  triangulation.set_boundary (1);
 }
 
 // There is one snag to doing things as shown above: If one moves the nodes on
index 27f0e2dbbb9fddc361402b79cf7ef58a2c0cf83e..f1d146935b83dec66687b652e1415de635e00913 100644 (file)
@@ -50,7 +50,7 @@
 
 // We will use a circular domain, and the object describing the boundary of it
 // comes from this file:
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 // This is C++ ...
 #include <fstream>
@@ -599,8 +599,8 @@ void Step5<dim>::run ()
   // the first example. Note that the HyperBallBoundary constructor takes two
   // parameters, the center of the ball and the radius, but that their default
   // (the origin and 1.0) are the ones which we would like to use here.
-  static const PolarManifold<dim> boundary;
-  triangulation.set_manifold (0, boundary);
+  static const HyperBallBoundary<dim> boundary;
+  triangulation.set_boundary (0, boundary);
 
   for (unsigned int cycle=0; cycle<6; ++cycle)
     {
index 8d13f6af4459ab3fcffbe2602f2764e1a85891bb..768281e4e703b0455d01ab5461d714a47d2a8dca 100644 (file)
@@ -61,7 +61,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/grid_refinement.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index c8b7a4ffcd69f2e4ef7b8f681f8ceba361cd2ef2..14be9e7875b49e5d9488230abd4cdf96cb6cae14 100644 (file)
@@ -40,7 +40,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_refinement.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_renumbering.h>
index 8ad4fcb9d865d4634ec4dd09ea5f7544ddd4c591..e3fca00b1e95487f764a1f658fe07b43d8eb709b 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
 #include <deal.II/fe/fe_values.h>
@@ -676,8 +676,8 @@ void Step6<dim>::run ()
         {
           GridGenerator::hyper_ball (triangulation);
 
-          static const PolarManifold<dim> boundary;
-          triangulation.set_manifold (0, boundary);
+          static const HyperBallBoundary<dim> boundary;
+          triangulation.set_boundary (0, boundary);
 
           triangulation.refine_global (1);
         }
index 0bce558c826fa3fed5ac6a631b3fbbde574b8f55..058e7cf1cdc05da7cf7e0b254d910de74a075622 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/grid/grid_refinement.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index f588f3272b4701315180834a591d41b99113a9ae..fbc9051c67387cb14690c9c09fbdd5e1d5d0dcf6 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/grid/grid_refinement.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index e162811691232893534d49024af222c97850c786..c1be3098142c8d73c22d3f6d67413cc9737db408 100644 (file)
@@ -35,7 +35,7 @@
 #include <deal.II/grid/grid_refinement.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>

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.