]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove an obsolete test. 6582/head
authorDavid Wells <wellsd2@rpi.edu>
Sat, 12 May 2018 18:44:45 +0000 (14:44 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Sun, 13 May 2018 18:21:59 +0000 (14:21 -0400)
The purpose of this test was to check the old 'use boundary_ids as manifold_ids'
code path: if the Boundary classes are completely removed then this test is
nearly identical to extract_boundary_mesh_11 and extract_boundary_mesh_12, so it
can be removed.

tests/codim_one/extract_boundary_mesh_10.cc [deleted file]
tests/codim_one/extract_boundary_mesh_10.output [deleted file]

diff --git a/tests/codim_one/extract_boundary_mesh_10.cc b/tests/codim_one/extract_boundary_mesh_10.cc
deleted file mode 100644 (file)
index 2e68c5e..0000000
+++ /dev/null
@@ -1,83 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2010 - 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 at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-// We can not copy boundary ids from edges of the volume mesh to edges
-// of the surface mesh in 3d because the boundary edges of the volume
-// mesh are not necessarily boundary edges of the surface mesh.
-//
-// if the original mesh's geometry was only defined via the boundary
-// indicators, this leads to a surface mesh with a geometry
-// description of edges that is not likely what was desired. there is
-// little one can do about it with only boundary_ids, and without
-// resorting to manifold_ids. this testcase in essence just ensures
-// that we continue to get this "undesirable" behavior until someone
-// comes up with a better idea
-//
-// In particular, it doesn't make sense to replace CylinderBoundary
-// by CylindricalManifold here as the problem then doesn't appear anymore.
-
-#include "../tests.h"
-
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_out.h>
-#include <deal.II/grid/grid_tools.h>
-#include <deal.II/grid/tria_boundary_lib.h>
-
-
-void test()
-{
-  const int dim=3;
-
-  Triangulation<dim>   triangulation;
-  GridGenerator::cylinder(triangulation, 100, 200);
-  GridTools::copy_boundary_to_manifold_id(triangulation);
-  for (auto cell = triangulation.begin_active(); cell != triangulation.end(); ++cell)
-    for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
-      if (cell->face(f)->boundary_id() != numbers::invalid_boundary_id)
-        for (unsigned int e=0; e<GeometryInfo<dim>::lines_per_face; ++e)
-          cell->face(f)->line(e)->set_manifold_id(cell->face(f)->boundary_id());
-
-  static const CylinderBoundary<dim> outer_cylinder (100,0);
-  triangulation.set_manifold(0,outer_cylinder);
-
-  // now extract the surface mesh
-  Triangulation<dim-1,dim> triangulation_surface;
-
-  static const CylinderBoundary<dim-1,dim> surface_cyl(100,0);
-  triangulation_surface.set_manifold(0,surface_cyl);
-
-  GridGenerator::extract_boundary_mesh(triangulation,triangulation_surface);
-
-  // refine the surface mesh to see the effect of boundary/manifold
-  // indicators
-  triangulation_surface.refine_global (1);
-  GridOut().write_gnuplot(triangulation_surface, deallog.get_file_stream());
-
-  std::ofstream output ("grid.vtk");
-  GridOut().write_vtk(triangulation_surface, output);
-
-  deallog << triangulation_surface.n_used_vertices() << std::endl;
-  deallog << triangulation_surface.n_active_cells() << std::endl;
-}
-
-
-int main ()
-{
-  initlog();
-
-  test();
-}
diff --git a/tests/codim_one/extract_boundary_mesh_10.output b/tests/codim_one/extract_boundary_mesh_10.output
deleted file mode 100644 (file)
index 65e6d91..0000000
+++ /dev/null
@@ -1,507 +0,0 @@
-
--200.000 70.7107 -70.7107 1 1
--200.000 50.0000 -50.0000 1 1
--200.000 0.00000 -53.6612 1 1
--200.000 0.00000 -100.000 1 1
--200.000 70.7107 -70.7107 1 1
-
-
--200.000 50.0000 -50.0000 1 1
--200.000 29.2893 -29.2893 1 1
--200.000 0.00000 -29.2893 1 1
--200.000 0.00000 -53.6612 1 1
--200.000 50.0000 -50.0000 1 1
-
-
--200.000 0.00000 -100.000 1 1
--200.000 0.00000 -53.6612 1 1
--200.000 -50.0000 -50.0000 1 1
--200.000 -70.7107 -70.7107 1 1
--200.000 0.00000 -100.000 1 1
-
-
--200.000 0.00000 -53.6612 1 1
--200.000 0.00000 -29.2893 1 1
--200.000 -29.2893 -29.2893 1 1
--200.000 -50.0000 -50.0000 1 1
--200.000 0.00000 -53.6612 1 1
-
-
--200.000 70.7107 -70.7107 1 0
--200.000 0.00000 -100.000 1 0
--100.000 0.00000 -100.000 1 0
--100.000 70.7107 -70.7107 1 0
--200.000 70.7107 -70.7107 1 0
-
-
--200.000 0.00000 -100.000 1 0
--200.000 -70.7107 -70.7107 1 0
--100.000 -70.7107 -70.7107 1 0
--100.000 0.00000 -100.000 1 0
--200.000 0.00000 -100.000 1 0
-
-
--100.000 70.7107 -70.7107 1 0
--100.000 0.00000 -100.000 1 0
-0.00000 0.00000 -100.000 1 0
-0.00000 70.7107 -70.7107 1 0
--100.000 70.7107 -70.7107 1 0
-
-
--100.000 0.00000 -100.000 1 0
--100.000 -70.7107 -70.7107 1 0
-0.00000 -70.7107 -70.7107 1 0
-0.00000 0.00000 -100.000 1 0
--100.000 0.00000 -100.000 1 0
-
-
--200.000 70.7107 -70.7107 1 0
--100.000 70.7107 -70.7107 1 0
--100.000 100.000 0.00000 1 0
--200.000 70.7107 0.00000 1 0
--200.000 70.7107 -70.7107 1 0
-
-
--100.000 70.7107 -70.7107 1 0
-0.00000 70.7107 -70.7107 1 0
-0.00000 100.000 0.00000 1 0
--100.000 100.000 0.00000 1 0
--100.000 70.7107 -70.7107 1 0
-
-
--200.000 70.7107 0.00000 1 0
--100.000 100.000 0.00000 1 0
--100.000 70.7107 70.7107 1 0
--200.000 70.7107 70.7107 1 0
--200.000 70.7107 0.00000 1 0
-
-
--100.000 100.000 0.00000 1 0
-0.00000 100.000 0.00000 1 0
-0.00000 70.7107 70.7107 1 0
--100.000 70.7107 70.7107 1 0
--100.000 100.000 0.00000 1 0
-
-
--200.000 70.7107 -70.7107 1 1
--200.000 70.7107 0.00000 1 1
--200.000 50.0000 0.00000 1 1
--200.000 50.0000 -50.0000 1 1
--200.000 70.7107 -70.7107 1 1
-
-
--200.000 70.7107 0.00000 1 1
--200.000 70.7107 70.7107 1 1
--200.000 50.0000 50.0000 1 1
--200.000 50.0000 0.00000 1 1
--200.000 70.7107 0.00000 1 1
-
-
--200.000 50.0000 -50.0000 1 1
--200.000 50.0000 0.00000 1 1
--200.000 29.2893 0.00000 1 1
--200.000 29.2893 -29.2893 1 1
--200.000 50.0000 -50.0000 1 1
-
-
--200.000 50.0000 0.00000 1 1
--200.000 50.0000 50.0000 1 1
--200.000 29.2893 29.2893 1 1
--200.000 29.2893 0.00000 1 1
--200.000 50.0000 0.00000 1 1
-
-
--200.000 29.2893 -29.2893 1 1
--200.000 29.2893 0.00000 1 1
--200.000 0.00000 0.00000 1 1
--200.000 0.00000 -29.2893 1 1
--200.000 29.2893 -29.2893 1 1
-
-
--200.000 29.2893 0.00000 1 1
--200.000 29.2893 29.2893 1 1
--200.000 0.00000 29.2893 1 1
--200.000 0.00000 0.00000 1 1
--200.000 29.2893 0.00000 1 1
-
-
--200.000 0.00000 -29.2893 1 1
--200.000 0.00000 0.00000 1 1
--200.000 -29.2893 0.00000 1 1
--200.000 -29.2893 -29.2893 1 1
--200.000 0.00000 -29.2893 1 1
-
-
--200.000 0.00000 0.00000 1 1
--200.000 0.00000 29.2893 1 1
--200.000 -29.2893 29.2893 1 1
--200.000 -29.2893 0.00000 1 1
--200.000 0.00000 0.00000 1 1
-
-
--200.000 -70.7107 -70.7107 1 1
--200.000 -50.0000 -50.0000 1 1
--200.000 -53.6612 0.00000 1 1
--200.000 -100.000 0.00000 1 1
--200.000 -70.7107 -70.7107 1 1
-
-
--200.000 -50.0000 -50.0000 1 1
--200.000 -29.2893 -29.2893 1 1
--200.000 -29.2893 0.00000 1 1
--200.000 -53.6612 0.00000 1 1
--200.000 -50.0000 -50.0000 1 1
-
-
--200.000 -100.000 0.00000 1 1
--200.000 -53.6612 0.00000 1 1
--200.000 -50.0000 50.0000 1 1
--200.000 -70.7107 70.7107 1 1
--200.000 -100.000 0.00000 1 1
-
-
--200.000 -53.6612 0.00000 1 1
--200.000 -29.2893 0.00000 1 1
--200.000 -29.2893 29.2893 1 1
--200.000 -50.0000 50.0000 1 1
--200.000 -53.6612 0.00000 1 1
-
-
--200.000 -70.7107 -70.7107 1 0
--200.000 -100.000 0.00000 1 0
--100.000 -100.000 0.00000 1 0
--100.000 -70.7107 -70.7107 1 0
--200.000 -70.7107 -70.7107 1 0
-
-
--200.000 -100.000 0.00000 1 0
--200.000 -70.7107 70.7107 1 0
--100.000 -70.7107 70.7107 1 0
--100.000 -100.000 0.00000 1 0
--200.000 -100.000 0.00000 1 0
-
-
--100.000 -70.7107 -70.7107 1 0
--100.000 -100.000 0.00000 1 0
-0.00000 -100.000 0.00000 1 0
-0.00000 -70.7107 -70.7107 1 0
--100.000 -70.7107 -70.7107 1 0
-
-
--100.000 -100.000 0.00000 1 0
--100.000 -70.7107 70.7107 1 0
-0.00000 -70.7107 70.7107 1 0
-0.00000 -100.000 0.00000 1 0
--100.000 -100.000 0.00000 1 0
-
-
--200.000 70.7107 70.7107 1 0
--100.000 70.7107 70.7107 1 0
--100.000 0.00000 100.000 1 0
--200.000 0.00000 70.7107 1 0
--200.000 70.7107 70.7107 1 0
-
-
--100.000 70.7107 70.7107 1 0
-0.00000 70.7107 70.7107 1 0
-0.00000 0.00000 100.000 1 0
--100.000 0.00000 100.000 1 0
--100.000 70.7107 70.7107 1 0
-
-
--200.000 0.00000 70.7107 1 0
--100.000 0.00000 100.000 1 0
--100.000 -70.7107 70.7107 1 0
--200.000 -70.7107 70.7107 1 0
--200.000 0.00000 70.7107 1 0
-
-
--100.000 0.00000 100.000 1 0
-0.00000 0.00000 100.000 1 0
-0.00000 -70.7107 70.7107 1 0
--100.000 -70.7107 70.7107 1 0
--100.000 0.00000 100.000 1 0
-
-
--200.000 70.7107 70.7107 1 1
--200.000 0.00000 70.7107 1 1
--200.000 0.00000 50.0000 1 1
--200.000 50.0000 50.0000 1 1
--200.000 70.7107 70.7107 1 1
-
-
--200.000 0.00000 70.7107 1 1
--200.000 -70.7107 70.7107 1 1
--200.000 -50.0000 50.0000 1 1
--200.000 0.00000 50.0000 1 1
--200.000 0.00000 70.7107 1 1
-
-
--200.000 50.0000 50.0000 1 1
--200.000 0.00000 50.0000 1 1
--200.000 0.00000 29.2893 1 1
--200.000 29.2893 29.2893 1 1
--200.000 50.0000 50.0000 1 1
-
-
--200.000 0.00000 50.0000 1 1
--200.000 -50.0000 50.0000 1 1
--200.000 -29.2893 29.2893 1 1
--200.000 0.00000 29.2893 1 1
--200.000 0.00000 50.0000 1 1
-
-
-200.000 70.7107 -70.7107 1 2
-200.000 0.00000 -100.000 1 2
-200.000 0.00000 -53.6612 1 2
-200.000 50.0000 -50.0000 1 2
-200.000 70.7107 -70.7107 1 2
-
-
-200.000 0.00000 -100.000 1 2
-200.000 -70.7107 -70.7107 1 2
-200.000 -50.0000 -50.0000 1 2
-200.000 0.00000 -53.6612 1 2
-200.000 0.00000 -100.000 1 2
-
-
-200.000 50.0000 -50.0000 1 2
-200.000 0.00000 -53.6612 1 2
-200.000 0.00000 -29.2893 1 2
-200.000 29.2893 -29.2893 1 2
-200.000 50.0000 -50.0000 1 2
-
-
-200.000 0.00000 -53.6612 1 2
-200.000 -50.0000 -50.0000 1 2
-200.000 -29.2893 -29.2893 1 2
-200.000 0.00000 -29.2893 1 2
-200.000 0.00000 -53.6612 1 2
-
-
-0.00000 70.7107 -70.7107 1 0
-0.00000 0.00000 -100.000 1 0
-100.000 0.00000 -100.000 1 0
-100.000 70.7107 -70.7107 1 0
-0.00000 70.7107 -70.7107 1 0
-
-
-0.00000 0.00000 -100.000 1 0
-0.00000 -70.7107 -70.7107 1 0
-100.000 -70.7107 -70.7107 1 0
-100.000 0.00000 -100.000 1 0
-0.00000 0.00000 -100.000 1 0
-
-
-100.000 70.7107 -70.7107 1 0
-100.000 0.00000 -100.000 1 0
-200.000 0.00000 -100.000 1 0
-200.000 70.7107 -70.7107 1 0
-100.000 70.7107 -70.7107 1 0
-
-
-100.000 0.00000 -100.000 1 0
-100.000 -70.7107 -70.7107 1 0
-200.000 -70.7107 -70.7107 1 0
-200.000 0.00000 -100.000 1 0
-100.000 0.00000 -100.000 1 0
-
-
-0.00000 70.7107 -70.7107 1 0
-100.000 70.7107 -70.7107 1 0
-100.000 100.000 0.00000 1 0
-0.00000 100.000 0.00000 1 0
-0.00000 70.7107 -70.7107 1 0
-
-
-100.000 70.7107 -70.7107 1 0
-200.000 70.7107 -70.7107 1 0
-200.000 70.7107 0.00000 1 0
-100.000 100.000 0.00000 1 0
-100.000 70.7107 -70.7107 1 0
-
-
-0.00000 100.000 0.00000 1 0
-100.000 100.000 0.00000 1 0
-100.000 70.7107 70.7107 1 0
-0.00000 70.7107 70.7107 1 0
-0.00000 100.000 0.00000 1 0
-
-
-100.000 100.000 0.00000 1 0
-200.000 70.7107 0.00000 1 0
-200.000 70.7107 70.7107 1 0
-100.000 70.7107 70.7107 1 0
-100.000 100.000 0.00000 1 0
-
-
-200.000 70.7107 -70.7107 1 2
-200.000 50.0000 -50.0000 1 2
-200.000 50.0000 0.00000 1 2
-200.000 70.7107 0.00000 1 2
-200.000 70.7107 -70.7107 1 2
-
-
-200.000 50.0000 -50.0000 1 2
-200.000 29.2893 -29.2893 1 2
-200.000 29.2893 0.00000 1 2
-200.000 50.0000 0.00000 1 2
-200.000 50.0000 -50.0000 1 2
-
-
-200.000 70.7107 0.00000 1 2
-200.000 50.0000 0.00000 1 2
-200.000 50.0000 50.0000 1 2
-200.000 70.7107 70.7107 1 2
-200.000 70.7107 0.00000 1 2
-
-
-200.000 50.0000 0.00000 1 2
-200.000 29.2893 0.00000 1 2
-200.000 29.2893 29.2893 1 2
-200.000 50.0000 50.0000 1 2
-200.000 50.0000 0.00000 1 2
-
-
-200.000 29.2893 -29.2893 1 2
-200.000 0.00000 -29.2893 1 2
-200.000 0.00000 0.00000 1 2
-200.000 29.2893 0.00000 1 2
-200.000 29.2893 -29.2893 1 2
-
-
-200.000 0.00000 -29.2893 1 2
-200.000 -29.2893 -29.2893 1 2
-200.000 -29.2893 0.00000 1 2
-200.000 0.00000 0.00000 1 2
-200.000 0.00000 -29.2893 1 2
-
-
-200.000 29.2893 0.00000 1 2
-200.000 0.00000 0.00000 1 2
-200.000 0.00000 29.2893 1 2
-200.000 29.2893 29.2893 1 2
-200.000 29.2893 0.00000 1 2
-
-
-200.000 0.00000 0.00000 1 2
-200.000 -29.2893 0.00000 1 2
-200.000 -29.2893 29.2893 1 2
-200.000 0.00000 29.2893 1 2
-200.000 0.00000 0.00000 1 2
-
-
-200.000 -70.7107 -70.7107 1 2
-200.000 -100.000 0.00000 1 2
-200.000 -53.6612 0.00000 1 2
-200.000 -50.0000 -50.0000 1 2
-200.000 -70.7107 -70.7107 1 2
-
-
-200.000 -100.000 0.00000 1 2
-200.000 -70.7107 70.7107 1 2
-200.000 -50.0000 50.0000 1 2
-200.000 -53.6612 0.00000 1 2
-200.000 -100.000 0.00000 1 2
-
-
-200.000 -50.0000 -50.0000 1 2
-200.000 -53.6612 0.00000 1 2
-200.000 -29.2893 0.00000 1 2
-200.000 -29.2893 -29.2893 1 2
-200.000 -50.0000 -50.0000 1 2
-
-
-200.000 -53.6612 0.00000 1 2
-200.000 -50.0000 50.0000 1 2
-200.000 -29.2893 29.2893 1 2
-200.000 -29.2893 0.00000 1 2
-200.000 -53.6612 0.00000 1 2
-
-
-0.00000 -70.7107 -70.7107 1 0
-0.00000 -100.000 0.00000 1 0
-100.000 -100.000 0.00000 1 0
-100.000 -70.7107 -70.7107 1 0
-0.00000 -70.7107 -70.7107 1 0
-
-
-0.00000 -100.000 0.00000 1 0
-0.00000 -70.7107 70.7107 1 0
-100.000 -70.7107 70.7107 1 0
-100.000 -100.000 0.00000 1 0
-0.00000 -100.000 0.00000 1 0
-
-
-100.000 -70.7107 -70.7107 1 0
-100.000 -100.000 0.00000 1 0
-200.000 -100.000 0.00000 1 0
-200.000 -70.7107 -70.7107 1 0
-100.000 -70.7107 -70.7107 1 0
-
-
-100.000 -100.000 0.00000 1 0
-100.000 -70.7107 70.7107 1 0
-200.000 -70.7107 70.7107 1 0
-200.000 -100.000 0.00000 1 0
-100.000 -100.000 0.00000 1 0
-
-
-0.00000 70.7107 70.7107 1 0
-100.000 70.7107 70.7107 1 0
-100.000 0.00000 100.000 1 0
-0.00000 0.00000 100.000 1 0
-0.00000 70.7107 70.7107 1 0
-
-
-100.000 70.7107 70.7107 1 0
-200.000 70.7107 70.7107 1 0
-200.000 0.00000 70.7107 1 0
-100.000 0.00000 100.000 1 0
-100.000 70.7107 70.7107 1 0
-
-
-0.00000 0.00000 100.000 1 0
-100.000 0.00000 100.000 1 0
-100.000 -70.7107 70.7107 1 0
-0.00000 -70.7107 70.7107 1 0
-0.00000 0.00000 100.000 1 0
-
-
-100.000 0.00000 100.000 1 0
-200.000 0.00000 70.7107 1 0
-200.000 -70.7107 70.7107 1 0
-100.000 -70.7107 70.7107 1 0
-100.000 0.00000 100.000 1 0
-
-
-200.000 70.7107 70.7107 1 2
-200.000 50.0000 50.0000 1 2
-200.000 0.00000 50.0000 1 2
-200.000 0.00000 70.7107 1 2
-200.000 70.7107 70.7107 1 2
-
-
-200.000 50.0000 50.0000 1 2
-200.000 29.2893 29.2893 1 2
-200.000 0.00000 29.2893 1 2
-200.000 0.00000 50.0000 1 2
-200.000 50.0000 50.0000 1 2
-
-
-200.000 0.00000 70.7107 1 2
-200.000 0.00000 50.0000 1 2
-200.000 -50.0000 50.0000 1 2
-200.000 -70.7107 70.7107 1 2
-200.000 0.00000 70.7107 1 2
-
-
-200.000 0.00000 50.0000 1 2
-200.000 0.00000 29.2893 1 2
-200.000 -29.2893 29.2893 1 2
-200.000 -50.0000 50.0000 1 2
-200.000 0.00000 50.0000 1 2
-
-
-DEAL::74
-DEAL::72

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.