]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fixed all examples, so that they use manifold instead of boundary. Only the code...
authorheltai <heltai@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 22 Aug 2013 14:24:48 +0000 (14:24 +0000)
committerheltai <heltai@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 22 Aug 2013 14:24:48 +0000 (14:24 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_manifold_id@30417 0785d39b-7218-0410-832d-ea1e28bc413d

28 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-47/step-47.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 724dd45e95f0afd702e6ba03da5007adc0b09780..96c701da2ac6a7e7ff4cba98338ceb68664b60af 100644 (file)
@@ -1,20 +1,18 @@
-/* ---------------------------------------------------------------------
- * $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}
@@ -38,8 +36,6 @@
 // And this for the declarations of the `sqrt' and `fabs' functions:
 #include <cmath>
 
-#include <deal.II/../../source/grid/manifold_lib.cc>
-
 // The final step in importing deal.II is this: All deal.II functions and
 // classes are in a namespace <code>dealii</code>, to make sure they don't
 // clash with symbols from other libraries you may want to use in conjunction
@@ -75,9 +71,9 @@ void first_grid ()
   // Now we want to write a graphical representation of the mesh to an output
   // file. The GridOut class of deal.II can do that in a number of different
   // output formats; here, we choose encapsulated postscript (eps) format:
-  std::ofstream out ("grid-1.msh");
+  std::ofstream out ("grid-1.eps");
   GridOut grid_out;
-  grid_out.write_msh (triangulation, out);
+  grid_out.write_eps (triangulation, out);
 }
 
 
@@ -95,18 +91,13 @@ 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 explicitly to 10 as the last argument:
+  // but we choose to set it explicitely to 10 as the last argument:
   const Point<2> center (1,0);
   const double inner_radius = 0.5,
                outer_radius = 1.0;
   GridGenerator::hyper_shell (triangulation,
                               center, inner_radius, outer_radius,
                               10);
-
-   Triangulation<2>::active_cell_iterator
-      cell = triangulation.begin_active(),
-      endc = triangulation.end();       
-  
   // By default, the triangulation assumes that all boundaries are straight
   // and given by the cells of the coarse grid (which we just created). It
   // uses this information when cells at the boundary are refined and new
@@ -136,9 +127,6 @@ void second_grid ()
   // 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<5; ++step)
-  // triangulation.refine_global(1);
-  
-  // if(false)
     {
       // 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
@@ -197,9 +185,9 @@ void second_grid ()
   // Finally, after these five iterations of refinement, we want to again
   // write the resulting mesh to a file, again in eps format. This works just
   // as above:
-  std::ofstream out ("grid-2.msh");
+  std::ofstream out ("grid-2.eps");
   GridOut grid_out;
-  grid_out.write_msh (triangulation, out);
+  grid_out.write_eps (triangulation, out);
 
 
   // At this point, all objects created in this function will be destroyed in
@@ -218,26 +206,6 @@ void second_grid ()
   // fine.
 }
 
-void test_case()
-{
-  const unsigned int dim = 2;
-  
-  std::vector<Point<dim> > ps(2);
-  ps[0] = Point<dim>(1.0,1.0);
-  ps[1] = Point<dim>(-1.0,1.0);
-  
-  std::vector<double> ws(2, .5);
-
-  PolarManifold<dim> manifold;
-
-  Point<dim> p = manifold.get_new_point(ps, ws);
-  std::cout << "Point 0 : " << ps[0]
-           << ", Point 1: " << ps[1]
-           << ", computed point: " << p << std::endl;
-  
-  
-}
-
 
 
 // @sect3{The main function}
@@ -246,7 +214,6 @@ void test_case()
 // two subfunctions, which produce the two grids.
 int main ()
 {
-  // first_grid ();
+  first_grid ();
   second_grid ();
-  test_case();
 }
index f62c273b827df7ef675cac04891855f39f16407f..ba428482285afb5c911ac2a10f57cbfe6e12fd1c 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim> boundary;
-    triangulation.set_boundary (0, boundary);
+    static const PolarManifold<dim> boundary;
+    triangulation.set_manifold (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 HyperBallBoundary<dim> boundary;
-        triangulation.set_boundary (0, boundary);
+        static const PolarManifold<dim> boundary;
+        triangulation.set_manifold (0, boundary);
 
         const MappingQ<dim> mapping (degree);
 
@@ -352,8 +352,8 @@ namespace Step10
         Triangulation<dim> triangulation;
         GridGenerator::hyper_ball (triangulation);
 
-        static const HyperBallBoundary<dim> boundary;
-        triangulation.set_boundary (0, boundary);
+        static const PolarManifold<dim> boundary;
+        triangulation.set_manifold (0, boundary);
 
         const MappingQ<dim> mapping (degree);
         const FE_Q<dim>     fe (1);
index 49cfda2b255adcf888440840c16851f048965989..28775f4d2db4eebf1958d4e94d9fa5b7cfd6db7a 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim> boundary;
-    triangulation.set_boundary (0, boundary);
+    static const PolarManifold<dim> boundary;
+    triangulation.set_manifold (0, boundary);
 
     for (unsigned int cycle=0; cycle<6; ++cycle, triangulation.refine_global(1))
       {
index dca38227eb7be50e5f275a8735f3b9e95314be93..024f831d8440a52e10244ba04a35198103f70c70 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim> boundary;
-    triangulation.set_boundary (0, boundary);
+    static const PolarManifold<dim> boundary;
+    triangulation.set_manifold (0, boundary);
     triangulation.refine_global(2);
 
     // The Newton iteration starts next. During the first step we do not have
index f5e657493ea6c93ad4523bd9b3d20c65ed427b4e..86a8e4e6ba8bd786e5db06a7cd002c9d9318ac63 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim> boundary;
-            triangulation.set_boundary (0, boundary);
+            static const PolarManifold<dim> boundary;
+            triangulation.set_manifold (0, boundary);
 
             triangulation.refine_global (1);
           }
index 0b9499c8489861870524de170890227168445390..e6b5c907d9103e57269fc8878323d65875c9c88a 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index 9de024169afd4d575587797e59a36ff005b98a8b..bcd2add7291b95aa31cab694b6f4d6d56cec3853 100644 (file)
@@ -40,7 +40,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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
@@ -845,12 +845,12 @@ namespace Step18
     // z-axis. Note that the boundary objects need to live as long as the
     // triangulation does; we can achieve this by making the objects static,
     // which means that they live as long as the program runs:
-    static const CylinderBoundary<dim> inner_cylinder (inner_radius, 2);
-    static const CylinderBoundary<dim> outer_cylinder (outer_radius, 2);
+    static const CylinderManifold<dim> inner_cylinder (inner_radius, 2);
+    static const CylinderManifold<dim> outer_cylinder (outer_radius, 2);
     // We then attach these two objects to the triangulation, and make them
     // correspond to boundary indicators 2 and 3:
-    triangulation.set_boundary (2, inner_cylinder);
-    triangulation.set_boundary (3, outer_cylinder);
+    triangulation.set_manifold (2, inner_cylinder);
+    triangulation.set_manifold (3, outer_cylinder);
 
     // There's one more thing we have to take care of (we should have done so
     // above already, but for didactic reasons it was more appropriate to
index cb6cd25b2e45f253c6198a84917c0c535bafe8ca..173841e1f714c66c774b1e77cf2fb0c6850a7b5e 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperShellBoundary<2> boundary_description(center);
-  triangulation.set_boundary (0, boundary_description);
+  static const PolarManifold<2> boundary_description(center);
+  triangulation.set_manifold (0, boundary_description);
 
   for (unsigned int step=0; step<5; ++step)
     {
index 96ea2b04270445c35b8d9fb59fe519a5b6212966..7703cc0b28189d9f8de33d7b187bb27d451ee0ee 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_refinement.h>
 
index e44ea21f12a1f3a86eae012abbf38940552e021f..f711c4e6784faa8d1ec646c069d121ae8820a79a 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim> boundary_description (center, 1.);
-    triangulation.set_boundary (0,boundary_description);
+    static const PolarManifold<dim> boundary_description (center);
+    triangulation.set_manifold (0,boundary_description);
     triangulation.refine_global (7);
 
     time_step = GridTools::minimal_cell_diameter(triangulation) /
index f4365766fd7722059f8cfe391092857d21112685..475af6d47f137a972878bf3dc2cbaf5506e98e0f 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index 9c3360572bf6e836f3a71abf679ea5c14e691d8c..5278c7a1c24a7322d65eddfad1ff2ef410f83146 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim> boundary(focal_point, radius);
-    triangulation.set_boundary(1, boundary);
+    static const PolarManifold<dim> boundary(focal_point);
+    triangulation.set_manifold (1, boundary);
 
     // Now global refinement is executed. Cells near the transducer location
     // will be automatically refined according to the circle shaped boundary
index 0c7ccc8a8fc893ffffbbde661b5203374e801f5e..e991399a3abf822e7e32938929d8ae20e8802f8e 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_refinement.h>
 
@@ -3522,9 +3522,9 @@ namespace Step32
                                 EquationData::R1,
                                 (dim==3) ? 96 : 12,
                                 true);
-    static HyperShellBoundary<dim> boundary;
-    triangulation.set_boundary (0, boundary);
-    triangulation.set_boundary (1, boundary);
+    static PolarManifold<dim> boundary;
+    triangulation.set_manifold (0, boundary);
+    triangulation.set_manifold (1, boundary);
 
     global_Omega_diameter = GridTools::diameter (triangulation);
 
index 7eb237953a7825a27bb9c3a7d54b9cf12a2a054b..b3c7d1c3cf2bd8940cecaf1cb9e50dde672a397b 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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_boundary(1, boundary)
+    // out, in the read_domain() method, the tria.set_manifold (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 HyperBallBoundary<dim-1, dim> boundary(center,1.);
+    static const PolarManifold<dim> boundary(center);
 
     std::ifstream in;
     switch (dim)
@@ -517,7 +517,7 @@ namespace Step34
     gi.attach_triangulation (tria);
     gi.read_ucd (in);
 
-    tria.set_boundary(1, boundary);
+    tria.set_manifold (1, boundary);
   }
 
 
index 6dfe49d2e7bce7a136b66761032f94cd98b6fe20..5753231311314caa7a1887d3456307f75a3d576d 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/grid/grid_in.h>
 
 #include <deal.II/dofs/dof_handler.h>
index 8a2a17723df5e067a1f6da5735efee09bccba530..7dfea760be386f448a8855797151318a15dd521c 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/grid/grid_generator.h>
 
 #include <deal.II/multigrid/multigrid.h>
index d8d17da2b294a11bb9316c4d5b9b85a8f8049212..ac5c8a2c3d1e29d64ebdbd4d52f2cd0887259794 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim,spacedim> surface_description;
-    triangulation.set_boundary (0, surface_description);
+    static PolarManifold<spacedim> surface_description;
+    triangulation.set_manifold (0, surface_description);
 
     {
       Triangulation<spacedim> volume_mesh;
index efcdad4921e6a957744b796f023d08f6564223ba..81a5202a62a33e6e815857cd44806fb8522fcbd0 100644 (file)
@@ -31,7 +31,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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_renumbering.h>
 #include <deal.II/fe/fe_q.h>
@@ -755,8 +755,8 @@ void PlasticityContactProblem<dim>::make_grid() {
       GridTools::transform(&rotate_half_sphere, triangulation);
       Point < dim > shift(0.5, 0.5, 0.5);
       GridTools::shift(shift, triangulation);
-      static HyperBallBoundary<dim> boundary_description(Point<dim>(0.5,0.5,0.5), radius);
-      triangulation.set_boundary (0, boundary_description);
+      static PolarManifold<dim> boundary_description(Point<dim>(0.5,0.5,0.5));
+      triangulation.set_manifold (0, boundary_description);
 
       triangulation.refine_global(n_initial_refinements);
 
index 8983261329acc7159b60ebefbffea97cc620fa0e..fe51603a0b4de415296fee55717a802719c5401b 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 
 #include <deal.II/fe/fe_dgp_monomial.h>
 #include <deal.II/fe/fe_q.h>
index e607cb2d87178b32b54f9468728d439f08e83d59..89f687a95abe808a83875b5fc80246d22d8915db 100644 (file)
@@ -33,7 +33,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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
 #include <deal.II/fe/fe_q.h>
@@ -1065,8 +1065,8 @@ namespace Step47
             GridGenerator::hyper_ball (triangulation);
             //GridGenerator::hyper_cube (triangulation, -1, 1);
 
-            static const HyperBallBoundary<dim> boundary;
-            triangulation.set_boundary (0, boundary);
+            static const PolarManifold<dim> boundary;
+            triangulation.set_manifold (0, boundary);
 
             triangulation.refine_global (2);
           }
index a1139eb765b14f070a2d4dfcf5f894184c99de68..a7f36f260da2894cba8ba463e3185c0e38745a50 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<2> boundary_description(Point<2>(0,0), 0.25);
-  triangulation.set_boundary (1, boundary_description);
+  const  PolarManifold<2> boundary_description(Point<2>(0,0));
+  triangulation.set_manifold (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_boundary (1);
+  triangulation.set_manifold (1);
 }
 
 // There is one snag to doing things as shown above: If one moves the nodes on
index f1d146935b83dec66687b652e1415de635e00913..27f0e2dbbb9fddc361402b79cf7ef58a2c0cf83e 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim> boundary;
-  triangulation.set_boundary (0, boundary);
+  static const PolarManifold<dim> boundary;
+  triangulation.set_manifold (0, boundary);
 
   for (unsigned int cycle=0; cycle<6; ++cycle)
     {
index b1398c7362cc557b11c9870a34f7f732dfc87e8e..72198b1a4d4d2e7b268d74ab98fe95b84dbd7999 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index bc4778c23a94f06c07a0ac9410728746548c84e2..ab772a39a11872e17468c8099559bdcf46306def 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_renumbering.h>
index 681b9e4a34c900e7392b83bd7807b50e989baf75..0f9495a5ead57f2052b589f695932c41a126d0a3 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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 HyperBallBoundary<dim> boundary;
-          triangulation.set_boundary (0, boundary);
+          static const PolarManifold<dim> boundary;
+          triangulation.set_manifold (0, boundary);
 
           triangulation.refine_global (1);
         }
index 058e7cf1cdc05da7cf7e0b254d910de74a075622..0bce558c826fa3fed5ac6a631b3fbbde574b8f55 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index da7eccfd573283f8913c15fe6bdb4f08c02ebb41..27043e2db1603dae9d310e981582d0e6bd105894 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
index 9f6883e273e02f56fefc0c1a82e6d15bf9d6ac08..1feb9d9c0a5a7b1b8991db453a44dfd9e82bad14 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/tria_boundary_lib.h>
+#include <deal.II/grid/manifold_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.