]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove some tests for distorted cells that now no longer are distorted.
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Sat, 2 Dec 2017 20:00:50 +0000 (21:00 +0100)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Tue, 12 Dec 2017 08:58:05 +0000 (09:58 +0100)
Keep the distorted_cells_06 test in to ensure that we really do not regress on this case.

tests/bits/distorted_cells_03.cc [deleted file]
tests/bits/distorted_cells_03.debug.output [deleted file]
tests/bits/distorted_cells_06.cc
tests/bits/distorted_cells_06.debug.output
tests/bits/distorted_mapped_cells_02.cc [deleted file]
tests/bits/distorted_mapped_cells_02.debug.output [deleted file]

diff --git a/tests/bits/distorted_cells_03.cc b/tests/bits/distorted_cells_03.cc
deleted file mode 100644 (file)
index 038adeb..0000000
+++ /dev/null
@@ -1,130 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2003 - 2015 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.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check that indeed Triangulation::execute_coarsening_and_refinement
-// throws an exception if a distorted child cell is created
-//
-// the 2d case is as described in the example in the Glossary on
-// distorted cells resulting from refinement
-
-#include "../tests.h"
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/grid_reordering.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/tria_boundary.h>
-#include <deal.II/grid/grid_out.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_q.h>
-#include <deal.II/fe/fe_values.h>
-
-
-
-template <int dim>
-class MyBoundary : public Boundary<dim>
-{
-  virtual Point<dim>
-  get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) const
-  {
-    deallog << "Finding point between "
-            << line->vertex(0) << " and "
-            << line->vertex(1) << std::endl;
-
-    // in 2d, find a point that
-    // lies on the opposite side
-    // of the quad. in 3d, choose
-    // the midpoint of the edge
-    if (dim == 2)
-      return Point<dim>(0,0.75);
-    else
-      return (line->vertex(0) + line->vertex(1)) / 2;
-  }
-
-  virtual Point<dim>
-  get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) const
-  {
-    deallog << "Finding point between "
-            << quad->vertex(0) << " and "
-            << quad->vertex(1) << " and "
-            << quad->vertex(2) << " and "
-            << quad->vertex(3) << std::endl;
-
-    return Point<dim>(0,0,.75);
-  }
-};
-
-
-
-template <int dim>
-void check ()
-{
-  MyBoundary<dim> my_boundary;
-
-  // create a single square/cube
-  Triangulation<dim> coarse_grid (Triangulation<dim>::none, true);
-  GridGenerator::hyper_cube (coarse_grid, -1, 1);
-
-  // set bottom face to use MyBoundary
-  for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
-    if (coarse_grid.begin_active()->face(f)->center()[dim-1] == -1)
-      coarse_grid.begin_active()->face(f)->set_boundary_id (1);
-  coarse_grid.set_boundary (1, my_boundary);
-
-  // now try to refine this one
-  // cell. we should get an exception
-  bool flag = false;
-  try
-    {
-      coarse_grid.begin_active()->set_refine_flag ();
-      coarse_grid.execute_coarsening_and_refinement ();
-    }
-  catch (typename Triangulation<dim>::DistortedCellList &dcv)
-    {
-      flag = true;
-
-      deallog << dcv.distorted_cells.size() << " distorted cells"
-              << std::endl;
-      Assert (dcv.distorted_cells.front() == coarse_grid.begin(0),
-              ExcInternalError());
-
-      // ignore the exception, i.e. do not
-      // even attempt to fix up the problem
-      // (but see the _04 testcase for this)
-    }
-
-  Assert (flag == true, ExcInternalError());
-  Assert (coarse_grid.n_levels() == 2, ExcInternalError());
-  Assert (coarse_grid.n_active_cells() == 1<<dim, ExcInternalError());
-
-  // output the coordinates of the
-  // child cells
-  GridOut().write_gnuplot (coarse_grid, deallog.get_file_stream());
-}
-
-
-int main ()
-{
-  initlog();
-
-  check<2> ();
-  check<3> ();
-}
-
-
-
diff --git a/tests/bits/distorted_cells_03.debug.output b/tests/bits/distorted_cells_03.debug.output
deleted file mode 100644 (file)
index 3564f85..0000000
+++ /dev/null
@@ -1,225 +0,0 @@
-
-DEAL::Finding point between -1.00000 -1.00000 and 1.00000 -1.00000
-DEAL::1 distorted cells
--1.00000 -1.00000 1 0
-0.00000 0.750000 1 0
-0.00000 0.218750 1 0
--1.00000 0.00000 1 0
--1.00000 -1.00000 1 0
-
-
-0.00000 0.750000 1 0
-1.00000 -1.00000 1 0
-1.00000 0.00000 1 0
-0.00000 0.218750 1 0
-0.00000 0.750000 1 0
-
-
--1.00000 0.00000 1 0
-0.00000 0.218750 1 0
-0.00000 1.00000 1 0
--1.00000 1.00000 1 0
--1.00000 0.00000 1 0
-
-
-0.00000 0.218750 1 0
-1.00000 0.00000 1 0
-1.00000 1.00000 1 0
-0.00000 1.00000 1 0
-0.00000 0.218750 1 0
-
-
-DEAL::Finding point between -1.00000 -1.00000 -1.00000 and 1.00000 -1.00000 -1.00000 and -1.00000 1.00000 -1.00000 and 1.00000 1.00000 -1.00000
-DEAL::1 distorted cells
--1.00000 -1.00000 -1.00000 1 0
-0.00000 -1.00000 -1.00000 1 0
-0.00000 -1.00000 0.00000 1 0
--1.00000 -1.00000 0.00000 1 0
--1.00000 -1.00000 -1.00000 1 0
-
--1.00000 0.00000 -1.00000 1 0
-0.00000 0.00000 0.750000 1 0
-0.00000 0.00000 0.145833 1 0
--1.00000 0.00000 0.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
--1.00000 -1.00000 -1.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-0.00000 0.00000 0.750000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-0.00000 0.00000 0.145833 1 0
-
--1.00000 -1.00000 0.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-1.00000 -1.00000 -1.00000 1 0
-1.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 -1.00000 1 0
-
-0.00000 0.00000 0.750000 1 0
-1.00000 0.00000 -1.00000 1 0
-1.00000 0.00000 0.00000 1 0
-0.00000 0.00000 0.145833 1 0
-0.00000 0.00000 0.750000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-0.00000 0.00000 0.750000 1 0
-
-1.00000 -1.00000 -1.00000 1 0
-1.00000 0.00000 -1.00000 1 0
-
-1.00000 -1.00000 0.00000 1 0
-1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-0.00000 0.00000 0.145833 1 0
-
--1.00000 0.00000 -1.00000 1 0
-0.00000 0.00000 0.750000 1 0
-0.00000 0.00000 0.145833 1 0
--1.00000 0.00000 0.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
--1.00000 1.00000 -1.00000 1 0
-0.00000 1.00000 -1.00000 1 0
-0.00000 1.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
--1.00000 1.00000 -1.00000 1 0
-
--1.00000 0.00000 -1.00000 1 0
--1.00000 1.00000 -1.00000 1 0
-
-0.00000 0.00000 0.750000 1 0
-0.00000 1.00000 -1.00000 1 0
-
-0.00000 0.00000 0.145833 1 0
-0.00000 1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 0.750000 1 0
-1.00000 0.00000 -1.00000 1 0
-1.00000 0.00000 0.00000 1 0
-0.00000 0.00000 0.145833 1 0
-0.00000 0.00000 0.750000 1 0
-
-0.00000 1.00000 -1.00000 1 0
-1.00000 1.00000 -1.00000 1 0
-1.00000 1.00000 0.00000 1 0
-0.00000 1.00000 0.00000 1 0
-0.00000 1.00000 -1.00000 1 0
-
-0.00000 0.00000 0.750000 1 0
-0.00000 1.00000 -1.00000 1 0
-
-1.00000 0.00000 -1.00000 1 0
-1.00000 1.00000 -1.00000 1 0
-
-1.00000 0.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 0.145833 1 0
-0.00000 1.00000 0.00000 1 0
-
--1.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 1.00000 1 0
--1.00000 -1.00000 1.00000 1 0
--1.00000 -1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
-0.00000 0.00000 0.145833 1 0
-0.00000 0.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
--1.00000 -1.00000 0.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-0.00000 0.00000 0.145833 1 0
-
-0.00000 -1.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-
--1.00000 -1.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-1.00000 -1.00000 0.00000 1 0
-1.00000 -1.00000 1.00000 1 0
-0.00000 -1.00000 1.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-
-0.00000 0.00000 0.145833 1 0
-1.00000 0.00000 0.00000 1 0
-1.00000 0.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-0.00000 0.00000 0.145833 1 0
-
-0.00000 -1.00000 0.00000 1 0
-0.00000 0.00000 0.145833 1 0
-
-1.00000 -1.00000 0.00000 1 0
-1.00000 0.00000 0.00000 1 0
-
-1.00000 -1.00000 1.00000 1 0
-1.00000 0.00000 1.00000 1 0
-
-0.00000 -1.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
-0.00000 0.00000 0.145833 1 0
-0.00000 0.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
--1.00000 1.00000 0.00000 1 0
-0.00000 1.00000 0.00000 1 0
-0.00000 1.00000 1.00000 1 0
--1.00000 1.00000 1.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 0.145833 1 0
-0.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-
--1.00000 0.00000 1.00000 1 0
--1.00000 1.00000 1.00000 1 0
-
-0.00000 0.00000 0.145833 1 0
-1.00000 0.00000 0.00000 1 0
-1.00000 0.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-0.00000 0.00000 0.145833 1 0
-
-0.00000 1.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-1.00000 1.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-0.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 0.145833 1 0
-0.00000 1.00000 0.00000 1 0
-
-1.00000 0.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-
-1.00000 0.00000 1.00000 1 0
-1.00000 1.00000 1.00000 1 0
-
-0.00000 0.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-
index e2acf93d4482c82ae850321741cf43a67ea16f04..bc3e493c265efb6408a47b6a1dc080f5f8154c21 100644 (file)
@@ -80,7 +80,8 @@ void check ()
   coarse_grid.set_boundary (99, my_boundary);
 
   // now try to refine this one
-  // cell. we should get an exception
+  // cell. we should not get an exception, but keep it to make sure the
+  // program still runs
   try
     {
       coarse_grid.refine_global(1);
index 6ecd23c926836f1cca6ae3f07c5511d796b0a2d4..99ce7cd7ebc69a7029e92826635c0028bd1425a2 100644 (file)
@@ -1,7 +1,5 @@
 
 DEAL::Finding point between 0.00000 0.00000 0.00000 and 0.00000 1.00000 0.00000
-DEAL::Found 2 distorted cells
-DEAL::Found 0 cells that are still distorted
 -1.00000 0.00000 0.00000 1 6
 -0.500000 0.00000 0.00000 1 6
 -0.500000 0.00000 0.500000 1 6
@@ -9,8 +7,8 @@ DEAL::Found 0 cells that are still distorted
 -1.00000 0.00000 0.00000 1 6
 
 -1.00000 0.500000 0.00000 1 6
--0.500000 0.500000 0.112500 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.450000 1 6
+-0.500000 0.500000 0.725000 1 6
 -1.00000 0.500000 0.500000 1 6
 -1.00000 0.500000 0.00000 1 6
 
@@ -18,10 +16,10 @@ DEAL::Found 0 cells that are still distorted
 -1.00000 0.500000 0.00000 1 6
 
 -0.500000 0.00000 0.00000 1 6
--0.500000 0.500000 0.112500 1 6
+-0.500000 0.500000 0.450000 1 6
 
 -0.500000 0.00000 0.500000 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 
 -1.00000 0.00000 0.500000 1 6
 -1.00000 0.500000 0.500000 1 6
@@ -32,27 +30,27 @@ DEAL::Found 0 cells that are still distorted
 -0.500000 0.00000 0.500000 1 6
 -0.500000 0.00000 0.00000 1 6
 
--0.500000 0.500000 0.112500 1 6
+-0.500000 0.500000 0.450000 1 6
 0.00000 0.500000 0.900000 1 6
-0.00000 0.500000 0.919184 1 6
--0.510867 0.500000 0.533292 1 6
--0.500000 0.500000 0.112500 1 6
+0.00000 0.500000 0.950000 1 6
+-0.500000 0.500000 0.725000 1 6
+-0.500000 0.500000 0.450000 1 6
 
 -0.500000 0.00000 0.00000 1 6
--0.500000 0.500000 0.112500 1 6
+-0.500000 0.500000 0.450000 1 6
 
 0.00000 0.00000 0.00000 1 6
 0.00000 0.500000 0.900000 1 6
 
 0.00000 0.00000 0.500000 1 6
-0.00000 0.500000 0.919184 1 6
+0.00000 0.500000 0.950000 1 6
 
 -0.500000 0.00000 0.500000 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 
 -1.00000 0.500000 0.00000 1 6
--0.500000 0.500000 0.112500 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.450000 1 6
+-0.500000 0.500000 0.725000 1 6
 -1.00000 0.500000 0.500000 1 6
 -1.00000 0.500000 0.00000 1 6
 
@@ -65,20 +63,20 @@ DEAL::Found 0 cells that are still distorted
 -1.00000 0.500000 0.00000 1 6
 -1.00000 1.00000 0.00000 1 6
 
--0.500000 0.500000 0.112500 1 6
+-0.500000 0.500000 0.450000 1 6
 -0.500000 1.00000 0.00000 1 6
 
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 -0.500000 1.00000 0.500000 1 6
 
 -1.00000 0.500000 0.500000 1 6
 -1.00000 1.00000 0.500000 1 6
 
--0.500000 0.500000 0.112500 1 6
+-0.500000 0.500000 0.450000 1 6
 0.00000 0.500000 0.900000 1 6
-0.00000 0.500000 0.919184 1 6
--0.510867 0.500000 0.533292 1 6
--0.500000 0.500000 0.112500 1 6
+0.00000 0.500000 0.950000 1 6
+-0.500000 0.500000 0.725000 1 6
+-0.500000 0.500000 0.450000 1 6
 
 -0.500000 1.00000 0.00000 1 6
 0.00000 1.00000 0.00000 1 6
@@ -86,16 +84,16 @@ DEAL::Found 0 cells that are still distorted
 -0.500000 1.00000 0.500000 1 6
 -0.500000 1.00000 0.00000 1 6
 
--0.500000 0.500000 0.112500 1 6
+-0.500000 0.500000 0.450000 1 6
 -0.500000 1.00000 0.00000 1 6
 
 0.00000 0.500000 0.900000 1 6
 0.00000 1.00000 0.00000 1 6
 
-0.00000 0.500000 0.919184 1 6
+0.00000 0.500000 0.950000 1 6
 0.00000 1.00000 0.500000 1 6
 
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 -0.500000 1.00000 0.500000 1 6
 
 -1.00000 0.00000 0.500000 1 6
@@ -105,7 +103,7 @@ DEAL::Found 0 cells that are still distorted
 -1.00000 0.00000 0.500000 1 6
 
 -1.00000 0.500000 0.500000 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 -0.500000 0.500000 1.00000 1 6
 -1.00000 0.500000 1.00000 1 6
 -1.00000 0.500000 0.500000 1 6
@@ -114,7 +112,7 @@ DEAL::Found 0 cells that are still distorted
 -1.00000 0.500000 0.500000 1 6
 
 -0.500000 0.00000 0.500000 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 
 -0.500000 0.00000 1.00000 1 6
 -0.500000 0.500000 1.00000 1 6
@@ -128,17 +126,17 @@ DEAL::Found 0 cells that are still distorted
 -0.500000 0.00000 1.00000 1 6
 -0.500000 0.00000 0.500000 1 6
 
--0.510867 0.500000 0.533292 1 6
-0.00000 0.500000 0.919184 1 6
+-0.500000 0.500000 0.725000 1 6
+0.00000 0.500000 0.950000 1 6
 0.00000 0.500000 1.00000 1 6
 -0.500000 0.500000 1.00000 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 
 -0.500000 0.00000 0.500000 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 
 0.00000 0.00000 0.500000 1 6
-0.00000 0.500000 0.919184 1 6
+0.00000 0.500000 0.950000 1 6
 
 0.00000 0.00000 1.00000 1 6
 0.00000 0.500000 1.00000 1 6
@@ -147,7 +145,7 @@ DEAL::Found 0 cells that are still distorted
 -0.500000 0.500000 1.00000 1 6
 
 -1.00000 0.500000 0.500000 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 -0.500000 0.500000 1.00000 1 6
 -1.00000 0.500000 1.00000 1 6
 -1.00000 0.500000 0.500000 1 6
@@ -161,7 +159,7 @@ DEAL::Found 0 cells that are still distorted
 -1.00000 0.500000 0.500000 1 6
 -1.00000 1.00000 0.500000 1 6
 
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 -0.500000 1.00000 0.500000 1 6
 
 -0.500000 0.500000 1.00000 1 6
@@ -170,11 +168,11 @@ DEAL::Found 0 cells that are still distorted
 -1.00000 0.500000 1.00000 1 6
 -1.00000 1.00000 1.00000 1 6
 
--0.510867 0.500000 0.533292 1 6
-0.00000 0.500000 0.919184 1 6
+-0.500000 0.500000 0.725000 1 6
+0.00000 0.500000 0.950000 1 6
 0.00000 0.500000 1.00000 1 6
 -0.500000 0.500000 1.00000 1 6
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 
 -0.500000 1.00000 0.500000 1 6
 0.00000 1.00000 0.500000 1 6
@@ -182,10 +180,10 @@ DEAL::Found 0 cells that are still distorted
 -0.500000 1.00000 1.00000 1 6
 -0.500000 1.00000 0.500000 1 6
 
--0.510867 0.500000 0.533292 1 6
+-0.500000 0.500000 0.725000 1 6
 -0.500000 1.00000 0.500000 1 6
 
-0.00000 0.500000 0.919184 1 6
+0.00000 0.500000 0.950000 1 6
 0.00000 1.00000 0.500000 1 6
 
 0.00000 0.500000 1.00000 1 6
@@ -201,22 +199,22 @@ DEAL::Found 0 cells that are still distorted
 0.00000 0.00000 0.00000 1 7
 
 0.00000 0.500000 0.900000 1 7
-0.500000 0.500000 0.112500 1 7
-0.516302 0.500000 0.536649 1 7
-0.00000 0.500000 0.919184 1 7
+0.500000 0.500000 0.450000 1 7
+0.500000 0.500000 0.725000 1 7
+0.00000 0.500000 0.950000 1 7
 0.00000 0.500000 0.900000 1 7
 
 0.00000 0.00000 0.00000 1 7
 0.00000 0.500000 0.900000 1 7
 
 0.500000 0.00000 0.00000 1 7
-0.500000 0.500000 0.112500 1 7
+0.500000 0.500000 0.450000 1 7
 
 0.500000 0.00000 0.500000 1 7
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 
 0.00000 0.00000 0.500000 1 7
-0.00000 0.500000 0.919184 1 7
+0.00000 0.500000 0.950000 1 7
 
 0.500000 0.00000 0.00000 1 7
 1.00000 0.00000 0.00000 1 7
@@ -224,14 +222,14 @@ DEAL::Found 0 cells that are still distorted
 0.500000 0.00000 0.500000 1 7
 0.500000 0.00000 0.00000 1 7
 
-0.500000 0.500000 0.112500 1 7
+0.500000 0.500000 0.450000 1 7
 1.00000 0.500000 0.00000 1 7
 1.00000 0.500000 0.500000 1 7
-0.516302 0.500000 0.536649 1 7
-0.500000 0.500000 0.112500 1 7
+0.500000 0.500000 0.725000 1 7
+0.500000 0.500000 0.450000 1 7
 
 0.500000 0.00000 0.00000 1 7
-0.500000 0.500000 0.112500 1 7
+0.500000 0.500000 0.450000 1 7
 
 1.00000 0.00000 0.00000 1 7
 1.00000 0.500000 0.00000 1 7
@@ -240,12 +238,12 @@ DEAL::Found 0 cells that are still distorted
 1.00000 0.500000 0.500000 1 7
 
 0.500000 0.00000 0.500000 1 7
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 
 0.00000 0.500000 0.900000 1 7
-0.500000 0.500000 0.112500 1 7
-0.516302 0.500000 0.536649 1 7
-0.00000 0.500000 0.919184 1 7
+0.500000 0.500000 0.450000 1 7
+0.500000 0.500000 0.725000 1 7
+0.00000 0.500000 0.950000 1 7
 0.00000 0.500000 0.900000 1 7
 
 0.00000 1.00000 0.00000 1 7
@@ -257,20 +255,20 @@ DEAL::Found 0 cells that are still distorted
 0.00000 0.500000 0.900000 1 7
 0.00000 1.00000 0.00000 1 7
 
-0.500000 0.500000 0.112500 1 7
+0.500000 0.500000 0.450000 1 7
 0.500000 1.00000 0.00000 1 7
 
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 0.500000 1.00000 0.500000 1 7
 
-0.00000 0.500000 0.919184 1 7
+0.00000 0.500000 0.950000 1 7
 0.00000 1.00000 0.500000 1 7
 
-0.500000 0.500000 0.112500 1 7
+0.500000 0.500000 0.450000 1 7
 1.00000 0.500000 0.00000 1 7
 1.00000 0.500000 0.500000 1 7
-0.516302 0.500000 0.536649 1 7
-0.500000 0.500000 0.112500 1 7
+0.500000 0.500000 0.725000 1 7
+0.500000 0.500000 0.450000 1 7
 
 0.500000 1.00000 0.00000 1 7
 1.00000 1.00000 0.00000 1 7
@@ -278,7 +276,7 @@ DEAL::Found 0 cells that are still distorted
 0.500000 1.00000 0.500000 1 7
 0.500000 1.00000 0.00000 1 7
 
-0.500000 0.500000 0.112500 1 7
+0.500000 0.500000 0.450000 1 7
 0.500000 1.00000 0.00000 1 7
 
 1.00000 0.500000 0.00000 1 7
@@ -287,7 +285,7 @@ DEAL::Found 0 cells that are still distorted
 1.00000 0.500000 0.500000 1 7
 1.00000 1.00000 0.500000 1 7
 
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 0.500000 1.00000 0.500000 1 7
 
 0.00000 0.00000 0.500000 1 7
@@ -296,17 +294,17 @@ DEAL::Found 0 cells that are still distorted
 0.00000 0.00000 1.00000 1 7
 0.00000 0.00000 0.500000 1 7
 
-0.00000 0.500000 0.919184 1 7
-0.516302 0.500000 0.536649 1 7
+0.00000 0.500000 0.950000 1 7
+0.500000 0.500000 0.725000 1 7
 0.500000 0.500000 1.00000 1 7
 0.00000 0.500000 1.00000 1 7
-0.00000 0.500000 0.919184 1 7
+0.00000 0.500000 0.950000 1 7
 
 0.00000 0.00000 0.500000 1 7
-0.00000 0.500000 0.919184 1 7
+0.00000 0.500000 0.950000 1 7
 
 0.500000 0.00000 0.500000 1 7
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 
 0.500000 0.00000 1.00000 1 7
 0.500000 0.500000 1.00000 1 7
@@ -320,14 +318,14 @@ DEAL::Found 0 cells that are still distorted
 0.500000 0.00000 1.00000 1 7
 0.500000 0.00000 0.500000 1 7
 
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 1.00000 0.500000 0.500000 1 7
 1.00000 0.500000 1.00000 1 7
 0.500000 0.500000 1.00000 1 7
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 
 0.500000 0.00000 0.500000 1 7
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 
 1.00000 0.00000 0.500000 1 7
 1.00000 0.500000 0.500000 1 7
@@ -338,11 +336,11 @@ DEAL::Found 0 cells that are still distorted
 0.500000 0.00000 1.00000 1 7
 0.500000 0.500000 1.00000 1 7
 
-0.00000 0.500000 0.919184 1 7
-0.516302 0.500000 0.536649 1 7
+0.00000 0.500000 0.950000 1 7
+0.500000 0.500000 0.725000 1 7
 0.500000 0.500000 1.00000 1 7
 0.00000 0.500000 1.00000 1 7
-0.00000 0.500000 0.919184 1 7
+0.00000 0.500000 0.950000 1 7
 
 0.00000 1.00000 0.500000 1 7
 0.500000 1.00000 0.500000 1 7
@@ -350,10 +348,10 @@ DEAL::Found 0 cells that are still distorted
 0.00000 1.00000 1.00000 1 7
 0.00000 1.00000 0.500000 1 7
 
-0.00000 0.500000 0.919184 1 7
+0.00000 0.500000 0.950000 1 7
 0.00000 1.00000 0.500000 1 7
 
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 0.500000 1.00000 0.500000 1 7
 
 0.500000 0.500000 1.00000 1 7
@@ -362,11 +360,11 @@ DEAL::Found 0 cells that are still distorted
 0.00000 0.500000 1.00000 1 7
 0.00000 1.00000 1.00000 1 7
 
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 1.00000 0.500000 0.500000 1 7
 1.00000 0.500000 1.00000 1 7
 0.500000 0.500000 1.00000 1 7
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 
 0.500000 1.00000 0.500000 1 7
 1.00000 1.00000 0.500000 1 7
@@ -374,7 +372,7 @@ DEAL::Found 0 cells that are still distorted
 0.500000 1.00000 1.00000 1 7
 0.500000 1.00000 0.500000 1 7
 
-0.516302 0.500000 0.536649 1 7
+0.500000 0.500000 0.725000 1 7
 0.500000 1.00000 0.500000 1 7
 
 1.00000 0.500000 0.500000 1 7
diff --git a/tests/bits/distorted_mapped_cells_02.cc b/tests/bits/distorted_mapped_cells_02.cc
deleted file mode 100644 (file)
index c699e91..0000000
+++ /dev/null
@@ -1,79 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2013 - 2015 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.
-//
-// ---------------------------------------------------------------------
-
-
-// Test that an assertion is thrown when MappingQ distorts the geometry too
-// much on a thin hyper shell
-
-#include "../tests.h"
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/fe/mapping_q.h>
-#include <deal.II/fe/fe_nothing.h>
-#include <deal.II/fe/fe_values.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/tria_boundary_lib.h>
-
-
-void test()
-{
-  const int dim = 2;
-  Triangulation<dim> tria(Triangulation<dim>::none,true);
-
-  // shell is so narrow that MappingQ(2) distorts the cell
-  GridGenerator::quarter_hyper_shell (tria, Point<dim>(), 0.95, 1, 1);
-  static HyperShellBoundary<dim> boundary;
-  tria.set_boundary (0, boundary);
-
-  FE_Nothing<dim> dummy;
-  MappingQ<dim> mapping(2);
-  QGauss<dim> quad(2);
-  FEValues<dim> fe_val (mapping, dummy, quad, update_JxW_values);
-  double integral = 0.;
-  /*typename*/ Triangulation<dim>::active_cell_iterator
-  cell = tria.begin_active(), endc = tria.end();
-  for ( ; cell != endc; ++cell)
-    {
-      try
-        {
-          fe_val.reinit (cell);
-          for (unsigned int q=0; q<quad.size(); ++q)
-            integral += fe_val.JxW(q);
-        }
-      catch (ExceptionBase &e)
-        {
-          deallog << e.get_exc_name() << std::endl;
-        }
-    }
-  deallog << "Integral = " << integral << std::endl;
-}
-
-
-int
-main()
-{
-  deal_II_exceptions::disable_abort_on_exception();
-
-  std::ofstream logfile ("output");
-  deallog << std::setprecision(4) << std::fixed;
-  deallog.attach(logfile);
-
-  test();
-
-  return 0;
-}
-
-
-
diff --git a/tests/bits/distorted_mapped_cells_02.debug.output b/tests/bits/distorted_mapped_cells_02.debug.output
deleted file mode 100644 (file)
index 9314a3d..0000000
+++ /dev/null
@@ -1,3 +0,0 @@
-
-DEAL::(typename Mapping<dim,spacedim>::ExcDistortedMappedCell(cell->center(), det, point))
-DEAL::Integral = 0

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.