]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove files accidentally added.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 21 Apr 2009 22:25:20 +0000 (22:25 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 21 Apr 2009 22:25:20 +0000 (22:25 +0000)
git-svn-id: https://svn.dealii.org/trunk@18679 0785d39b-7218-0410-832d-ea1e28bc413d

tests/fe/cell_similarity_010.cc [deleted file]
tests/fe/cell_similarity_010/cmp/generic [deleted file]
tests/fe/cell_similarity_dgp_monomial_010.cc [deleted file]
tests/fe/cell_similarity_dgp_monomial_010/cmp/generic [deleted file]
tests/fe/cell_similarity_dgp_nonparametric_010.cc [deleted file]
tests/fe/cell_similarity_dgp_nonparametric_010/cmp/generic [deleted file]

diff --git a/tests/fe/cell_similarity_010.cc b/tests/fe/cell_similarity_010.cc
deleted file mode 100644 (file)
index d3bd42a..0000000
+++ /dev/null
@@ -1,174 +0,0 @@
-//----------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$ 
-//
-//    Copyright (C) 2009 by the deal.II authors
-//
-//    This file is subject to QPL and may not be  distributed
-//    without copyright and license information. Please refer
-//    to the file deal.II/doc/license.html for the  text  and
-//    further information on this license.
-//
-//----------------------------------------------------------------------
-
-
-// since early 2009, the FEValues objects try to be more efficient by only
-// recomputing things like gradients of shape functions if the cell on which
-// we are is not a translation of the previous one. in this series of tests we
-// make sure that this actually works the way it's supposed to be; in
-// particular, if we create a mesh of two identical cells but one has a curved
-// boundary, then they are the same if we use a Q1 mapping, but not a Q2
-// mapping. so we test that the mass matrix we get from each of these cells is
-// actually different in the latter case, but the same in the former
-//
-// the various tests cell_similarity_?? differ in the mappings and finite
-// elements in use
-
-
-#include "../tests.h"
-#include <base/logstream.h>
-#include <base/function.h>
-#include <base/quadrature_lib.h>
-#include <lac/vector.h>
-#include <grid/grid_generator.h>
-#include <grid/tria_boundary_lib.h>
-#include <dofs/dof_handler.h>
-#include <fe/fe_q.h>
-#include <fe/fe_dgq.h>
-#include <fe/fe_system.h>
-#include <fe/fe_values.h>
-#include <fe/mapping_q1.h>
-#include <fe/mapping_q.h>
-#include <fe/mapping_cartesian.h>
-
-#include <fstream>
-
-
-bool equal (const FullMatrix<double> &m1,
-           const FullMatrix<double> &m2)
-{
-  double d = 0, s = 0;
-  for (unsigned int i=0; i<m1.m(); ++i)
-    for (unsigned int j=0; j<m1.n(); ++j)
-      {
-       d += (m1(i,j)-m2(i,j)) * (m1(i,j)-m2(i,j));
-       s += m1(i,j) * m1(i,j);
-      }
-  return (d<1e-8*s);
-}
-
-
-template<int dim>
-void test (const Triangulation<dim>& tr)
-{
-  FE_Q<dim> fe(2);
-  deallog << "FE=" << fe.get_name() << std::endl;
-
-  MappingCartesian<dim> mapping;
-  deallog << "Mapping=Cartesian" << std::endl;
-
-  
-  DoFHandler<dim> dof(tr);
-  dof.distribute_dofs(fe);
-
-  const QGauss<dim> quadrature(2);
-  FEValues<dim> fe_values (mapping, fe, quadrature,
-                          update_values | update_gradients |
-                          update_JxW_values);
-
-  FullMatrix<double> mass_matrix[2], laplace_matrix[2];
-  mass_matrix[0].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  mass_matrix[1].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  laplace_matrix[0].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  laplace_matrix[1].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-
-  for (typename DoFHandler<dim>::active_cell_iterator
-        cell = dof.begin_active();
-       cell != dof.end(); ++cell)
-    {
-      fe_values.reinit (cell);
-
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-         for (unsigned int q=0; q<fe_values.n_quadrature_points; ++q)
-           {
-             mass_matrix[cell->index()](i,j) += fe_values.shape_value (i,q) *
-                                                fe_values.shape_value (j,q) *
-                                                fe_values.JxW(q);
-             laplace_matrix[cell->index()](i,j) += fe_values.shape_grad (i,q) *
-                                                   fe_values.shape_grad (j,q) *
-                                                   fe_values.JxW(q);    
-           }
-    }
-
-                                  // check what we expect for this mapping
-                                  // about equality or inequality of the
-                                  // matrices
-  deallog << "Mass matrices "
-         << (equal (mass_matrix[0], mass_matrix[1]) ? "are" : "are not")
-         << " equal."
-         << std::endl;
-  deallog << "Laplace matrices "
-         << (equal (laplace_matrix[0], laplace_matrix[1]) ? "are" : "are not")
-         << " equal."
-         << std::endl;
-  
-  for (unsigned int cell=0; cell<2; ++cell)
-    {
-      deallog << "cell=" << cell << std::endl;
-      deallog << "mass_matrix:" << std::endl;
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       {
-         for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-           deallog << mass_matrix[cell](i,j) << ' ';
-         deallog << std::endl;
-       }
-      
-      deallog << "laplace_matrix:" << std::endl;
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       {
-         for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-           deallog << laplace_matrix[cell](i,j) << ' ';
-         deallog << std::endl;
-       }
-    }
-}
-
-
-
-template <int dim>
-void test()
-{
-  Triangulation<dim> tr;
-  Point<dim> p1 = Point<dim>();
-  Point<dim> p2 = (dim == 2 ?
-                  Point<dim>(2,1) :
-                  Point<dim>(2,1,1));
-  std::vector<unsigned int> subdivisions (dim, 1);
-  subdivisions[0] = 2;
-  GridGenerator::subdivided_hyper_rectangle(tr, subdivisions, p1, p2);
-
-  static const HyperBallBoundary<dim> boundary;
-  tr.set_boundary (1, boundary);
-
-                                  // set boundary id on cell 1
-  for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
-    if (tr.begin_active()->at_boundary(f))
-      tr.begin_active()->face(f)->set_boundary_indicator (1);
-  
-  test(tr);
-}
-
-
-int main()
-{
-  std::ofstream logfile ("cell_similarity_10/output");
-  deallog << std::setprecision (4);
-
-  deallog.attach(logfile);
-  deallog.depth_console (0);
-  deallog.threshold_double(1.e-7);
-
-  test<2>();
-  //test<3>();
-}
diff --git a/tests/fe/cell_similarity_010/cmp/generic b/tests/fe/cell_similarity_010/cmp/generic
deleted file mode 100644 (file)
index d4520f9..0000000
+++ /dev/null
@@ -1,69 +0,0 @@
-
-DEAL::FE=FE_Q<2>(1)
-DEAL::Mapping=Q2
-DEAL::Mass matrices are not equal.
-DEAL::Laplace matrices are not equal.
-DEAL::cell=0
-DEAL::mass_matrix:
-DEAL::0.2371 0.07167 0.06719 0.02582 
-DEAL::0.07167 0.04962 0.02582 0.03610 
-DEAL::0.06719 0.02582 0.03170 0.03162 
-DEAL::0.02582 0.03610 0.03162 0.09477 
-DEAL::laplace_matrix:
-DEAL::4.337 -0.2381 -2.153 -1.946 
-DEAL::-0.2381 0.9387 -0.5940 -0.1066 
-DEAL::-2.153 -0.5940 1.899 0.8483 
-DEAL::-1.946 -0.1066 0.8483 1.205 
-DEAL::cell=1
-DEAL::mass_matrix:
-DEAL::0.1111 0.05556 0.05556 0.02778 
-DEAL::0.05556 0.1111 0.02778 0.05556 
-DEAL::0.05556 0.02778 0.1111 0.05556 
-DEAL::0.02778 0.05556 0.05556 0.1111 
-DEAL::laplace_matrix:
-DEAL::0.6667 -0.1667 -0.1667 -0.3333 
-DEAL::-0.1667 0.6667 -0.3333 -0.1667 
-DEAL::-0.1667 -0.3333 0.6667 -0.1667 
-DEAL::-0.3333 -0.1667 -0.1667 0.6667 
-DEAL::FE=FE_Q<3>(1)
-DEAL::Mapping=Q2
-DEAL::Mass matrices are not equal.
-DEAL::Laplace matrices are not equal.
-DEAL::cell=0
-DEAL::mass_matrix:
-DEAL::0.07572 0.02718 0.02414 0.009471 0.02414 0.009471 0.008538 0.003898 
-DEAL::0.02718 0.03298 0.009471 0.01375 0.009471 0.01375 0.003898 0.007053 
-DEAL::0.02414 0.009471 0.02083 0.01071 0.008538 0.003898 0.01001 0.006119 
-DEAL::0.009471 0.01375 0.01071 0.02201 0.003898 0.007053 0.006119 0.01447 
-DEAL::0.02414 0.009471 0.008538 0.003898 0.02083 0.01071 0.01001 0.006119 
-DEAL::0.009471 0.01375 0.003898 0.007053 0.01071 0.02201 0.006119 0.01447 
-DEAL::0.008538 0.003898 0.01001 0.006119 0.01001 0.006119 0.01922 0.01377 
-DEAL::0.003898 0.007053 0.006119 0.01447 0.006119 0.01447 0.01377 0.03585 
-DEAL::laplace_matrix:
-DEAL::0.7840 0.04931 0.04652 -0.2138 0.04652 -0.2138 -0.2672 -0.2315 
-DEAL::0.04931 0.3584 -0.04035 -0.04210 -0.04035 -0.04210 -0.09114 -0.1517 
-DEAL::0.04652 -0.04035 0.2547 0.006678 -0.03606 -0.07879 -0.03423 -0.1051 
-DEAL::-0.2138 -0.04210 0.006678 0.3292 -0.07879 -0.05266 0.002197 0.06269 
-DEAL::0.04652 -0.04035 -0.03606 -0.07879 0.2547 0.006678 -0.03423 -0.1051 
-DEAL::-0.2138 -0.04210 -0.07879 -0.05266 0.006678 0.3292 0.002197 0.06269 
-DEAL::-0.2672 -0.09114 -0.03423 0.002197 -0.03423 0.002197 0.3052 0.1173 
-DEAL::-0.2315 -0.1517 -0.1051 0.06269 -0.1051 0.06269 0.1173 0.3509 
-DEAL::cell=1
-DEAL::mass_matrix:
-DEAL::0.03704 0.01852 0.01852 0.009259 0.01852 0.009259 0.009259 0.004630 
-DEAL::0.01852 0.03704 0.009259 0.01852 0.009259 0.01852 0.004630 0.009259 
-DEAL::0.01852 0.009259 0.03704 0.01852 0.009259 0.004630 0.01852 0.009259 
-DEAL::0.009259 0.01852 0.01852 0.03704 0.004630 0.009259 0.009259 0.01852 
-DEAL::0.01852 0.009259 0.009259 0.004630 0.03704 0.01852 0.01852 0.009259 
-DEAL::0.009259 0.01852 0.004630 0.009259 0.01852 0.03704 0.009259 0.01852 
-DEAL::0.009259 0.004630 0.01852 0.009259 0.01852 0.009259 0.03704 0.01852 
-DEAL::0.004630 0.009259 0.009259 0.01852 0.009259 0.01852 0.01852 0.03704 
-DEAL::laplace_matrix:
-DEAL::0.3333 0 0 -0.08333 0 -0.08333 -0.08333 -0.08333 
-DEAL::0 0.3333 -0.08333 0 -0.08333 0 -0.08333 -0.08333 
-DEAL::0 -0.08333 0.3333 0 -0.08333 -0.08333 0 -0.08333 
-DEAL::-0.08333 0 0 0.3333 -0.08333 -0.08333 -0.08333 0 
-DEAL::0 -0.08333 -0.08333 -0.08333 0.3333 0 0 -0.08333 
-DEAL::-0.08333 0 -0.08333 -0.08333 0 0.3333 -0.08333 0 
-DEAL::-0.08333 -0.08333 0 -0.08333 0 -0.08333 0.3333 0 
-DEAL::-0.08333 -0.08333 -0.08333 0 -0.08333 0 0 0.3333 
diff --git a/tests/fe/cell_similarity_dgp_monomial_010.cc b/tests/fe/cell_similarity_dgp_monomial_010.cc
deleted file mode 100644 (file)
index e4057e2..0000000
+++ /dev/null
@@ -1,174 +0,0 @@
-//----------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$ 
-//
-//    Copyright (C) 2009 by the deal.II authors
-//
-//    This file is subject to QPL and may not be  distributed
-//    without copyright and license information. Please refer
-//    to the file deal.II/doc/license.html for the  text  and
-//    further information on this license.
-//
-//----------------------------------------------------------------------
-
-
-// since early 2009, the FEValues objects try to be more efficient by only
-// recomputing things like gradients of shape functions if the cell on which
-// we are is not a translation of the previous one. in this series of tests we
-// make sure that this actually works the way it's supposed to be; in
-// particular, if we create a mesh of two identical cells but one has a curved
-// boundary, then they are the same if we use a Q1 mapping, but not a Q2
-// mapping. so we test that the mass matrix we get from each of these cells is
-// actually different in the latter case, but the same in the former
-//
-// the various tests cell_similarity_dgp_monomial_?? differ in the mappings and finite
-// elements in use
-
-
-#include "../tests.h"
-#include <base/logstream.h>
-#include <base/function.h>
-#include <base/quadrature_lib.h>
-#include <lac/vector.h>
-#include <grid/grid_generator.h>
-#include <grid/tria_boundary_lib.h>
-#include <dofs/dof_handler.h>
-#include <fe/fe_q.h>
-#include <fe/fe_dgp_monomial.h>
-#include <fe/fe_system.h>
-#include <fe/fe_values.h>
-#include <fe/mapping_q1.h>
-#include <fe/mapping_q.h>
-#include <fe/mapping_cartesian.h>
-
-#include <fstream>
-
-
-bool equal (const FullMatrix<double> &m1,
-           const FullMatrix<double> &m2)
-{
-  double d = 0, s = 0;
-  for (unsigned int i=0; i<m1.m(); ++i)
-    for (unsigned int j=0; j<m1.n(); ++j)
-      {
-       d += (m1(i,j)-m2(i,j)) * (m1(i,j)-m2(i,j));
-       s += m1(i,j) * m1(i,j);
-      }
-  return (d<1e-8*s);
-}
-
-
-template<int dim>
-void test (const Triangulation<dim>& tr)
-{
-  FE_DGPMonomial<dim> fe(2);
-  deallog << "FE=" << fe.get_name() << std::endl;
-
-  MappingCartesian<dim> mapping;
-  deallog << "Mapping=Cartesian" << std::endl;
-
-  
-  DoFHandler<dim> dof(tr);
-  dof.distribute_dofs(fe);
-
-  const QGauss<dim> quadrature(2);
-  FEValues<dim> fe_values (mapping, fe, quadrature,
-                          update_values | update_gradients |
-                          update_JxW_values);
-
-  FullMatrix<double> mass_matrix[2], laplace_matrix[2];
-  mass_matrix[0].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  mass_matrix[1].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  laplace_matrix[0].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  laplace_matrix[1].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-
-  for (typename DoFHandler<dim>::active_cell_iterator
-        cell = dof.begin_active();
-       cell != dof.end(); ++cell)
-    {
-      fe_values.reinit (cell);
-
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-         for (unsigned int q=0; q<fe_values.n_quadrature_points; ++q)
-           {
-             mass_matrix[cell->index()](i,j) += fe_values.shape_value (i,q) *
-                                                fe_values.shape_value (j,q) *
-                                                fe_values.JxW(q);
-             laplace_matrix[cell->index()](i,j) += fe_values.shape_grad (i,q) *
-                                                   fe_values.shape_grad (j,q) *
-                                                   fe_values.JxW(q);    
-           }
-    }
-
-                                  // check what we expect for this mapping
-                                  // about equality or inequality of the
-                                  // matrices
-  deallog << "Mass matrices "
-         << (equal (mass_matrix[0], mass_matrix[1]) ? "are" : "are not")
-         << " equal."
-         << std::endl;
-  deallog << "Laplace matrices "
-         << (equal (laplace_matrix[0], laplace_matrix[1]) ? "are" : "are not")
-         << " equal."
-         << std::endl;
-  
-  for (unsigned int cell=0; cell<2; ++cell)
-    {
-      deallog << "cell=" << cell << std::endl;
-      deallog << "mass_matrix:" << std::endl;
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       {
-         for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-           deallog << mass_matrix[cell](i,j) << ' ';
-         deallog << std::endl;
-       }
-      
-      deallog << "laplace_matrix:" << std::endl;
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       {
-         for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-           deallog << laplace_matrix[cell](i,j) << ' ';
-         deallog << std::endl;
-       }
-    }
-}
-
-
-
-template <int dim>
-void test()
-{
-  Triangulation<dim> tr;
-  Point<dim> p1 = Point<dim>();
-  Point<dim> p2 = (dim == 2 ?
-                  Point<dim>(2,1) :
-                  Point<dim>(2,1,1));
-  std::vector<unsigned int> subdivisions (dim, 1);
-  subdivisions[0] = 2;
-  GridGenerator::subdivided_hyper_rectangle(tr, subdivisions, p1, p2);
-
-  static const HyperBallBoundary<dim> boundary;
-  tr.set_boundary (1, boundary);
-
-                                  // set boundary id on cell 1
-  for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
-    if (tr.begin_active()->at_boundary(f))
-      tr.begin_active()->face(f)->set_boundary_indicator (1);
-  
-  test(tr);
-}
-
-
-int main()
-{
-  std::ofstream logfile ("cell_similarity_dgp_monomial_10/output");
-  deallog << std::setprecision (4);
-
-  deallog.attach(logfile);
-  deallog.depth_console (0);
-  deallog.threshold_double(1.e-7);
-
-  test<2>();
-  //test<3>();
-}
diff --git a/tests/fe/cell_similarity_dgp_monomial_010/cmp/generic b/tests/fe/cell_similarity_dgp_monomial_010/cmp/generic
deleted file mode 100644 (file)
index d4520f9..0000000
+++ /dev/null
@@ -1,69 +0,0 @@
-
-DEAL::FE=FE_Q<2>(1)
-DEAL::Mapping=Q2
-DEAL::Mass matrices are not equal.
-DEAL::Laplace matrices are not equal.
-DEAL::cell=0
-DEAL::mass_matrix:
-DEAL::0.2371 0.07167 0.06719 0.02582 
-DEAL::0.07167 0.04962 0.02582 0.03610 
-DEAL::0.06719 0.02582 0.03170 0.03162 
-DEAL::0.02582 0.03610 0.03162 0.09477 
-DEAL::laplace_matrix:
-DEAL::4.337 -0.2381 -2.153 -1.946 
-DEAL::-0.2381 0.9387 -0.5940 -0.1066 
-DEAL::-2.153 -0.5940 1.899 0.8483 
-DEAL::-1.946 -0.1066 0.8483 1.205 
-DEAL::cell=1
-DEAL::mass_matrix:
-DEAL::0.1111 0.05556 0.05556 0.02778 
-DEAL::0.05556 0.1111 0.02778 0.05556 
-DEAL::0.05556 0.02778 0.1111 0.05556 
-DEAL::0.02778 0.05556 0.05556 0.1111 
-DEAL::laplace_matrix:
-DEAL::0.6667 -0.1667 -0.1667 -0.3333 
-DEAL::-0.1667 0.6667 -0.3333 -0.1667 
-DEAL::-0.1667 -0.3333 0.6667 -0.1667 
-DEAL::-0.3333 -0.1667 -0.1667 0.6667 
-DEAL::FE=FE_Q<3>(1)
-DEAL::Mapping=Q2
-DEAL::Mass matrices are not equal.
-DEAL::Laplace matrices are not equal.
-DEAL::cell=0
-DEAL::mass_matrix:
-DEAL::0.07572 0.02718 0.02414 0.009471 0.02414 0.009471 0.008538 0.003898 
-DEAL::0.02718 0.03298 0.009471 0.01375 0.009471 0.01375 0.003898 0.007053 
-DEAL::0.02414 0.009471 0.02083 0.01071 0.008538 0.003898 0.01001 0.006119 
-DEAL::0.009471 0.01375 0.01071 0.02201 0.003898 0.007053 0.006119 0.01447 
-DEAL::0.02414 0.009471 0.008538 0.003898 0.02083 0.01071 0.01001 0.006119 
-DEAL::0.009471 0.01375 0.003898 0.007053 0.01071 0.02201 0.006119 0.01447 
-DEAL::0.008538 0.003898 0.01001 0.006119 0.01001 0.006119 0.01922 0.01377 
-DEAL::0.003898 0.007053 0.006119 0.01447 0.006119 0.01447 0.01377 0.03585 
-DEAL::laplace_matrix:
-DEAL::0.7840 0.04931 0.04652 -0.2138 0.04652 -0.2138 -0.2672 -0.2315 
-DEAL::0.04931 0.3584 -0.04035 -0.04210 -0.04035 -0.04210 -0.09114 -0.1517 
-DEAL::0.04652 -0.04035 0.2547 0.006678 -0.03606 -0.07879 -0.03423 -0.1051 
-DEAL::-0.2138 -0.04210 0.006678 0.3292 -0.07879 -0.05266 0.002197 0.06269 
-DEAL::0.04652 -0.04035 -0.03606 -0.07879 0.2547 0.006678 -0.03423 -0.1051 
-DEAL::-0.2138 -0.04210 -0.07879 -0.05266 0.006678 0.3292 0.002197 0.06269 
-DEAL::-0.2672 -0.09114 -0.03423 0.002197 -0.03423 0.002197 0.3052 0.1173 
-DEAL::-0.2315 -0.1517 -0.1051 0.06269 -0.1051 0.06269 0.1173 0.3509 
-DEAL::cell=1
-DEAL::mass_matrix:
-DEAL::0.03704 0.01852 0.01852 0.009259 0.01852 0.009259 0.009259 0.004630 
-DEAL::0.01852 0.03704 0.009259 0.01852 0.009259 0.01852 0.004630 0.009259 
-DEAL::0.01852 0.009259 0.03704 0.01852 0.009259 0.004630 0.01852 0.009259 
-DEAL::0.009259 0.01852 0.01852 0.03704 0.004630 0.009259 0.009259 0.01852 
-DEAL::0.01852 0.009259 0.009259 0.004630 0.03704 0.01852 0.01852 0.009259 
-DEAL::0.009259 0.01852 0.004630 0.009259 0.01852 0.03704 0.009259 0.01852 
-DEAL::0.009259 0.004630 0.01852 0.009259 0.01852 0.009259 0.03704 0.01852 
-DEAL::0.004630 0.009259 0.009259 0.01852 0.009259 0.01852 0.01852 0.03704 
-DEAL::laplace_matrix:
-DEAL::0.3333 0 0 -0.08333 0 -0.08333 -0.08333 -0.08333 
-DEAL::0 0.3333 -0.08333 0 -0.08333 0 -0.08333 -0.08333 
-DEAL::0 -0.08333 0.3333 0 -0.08333 -0.08333 0 -0.08333 
-DEAL::-0.08333 0 0 0.3333 -0.08333 -0.08333 -0.08333 0 
-DEAL::0 -0.08333 -0.08333 -0.08333 0.3333 0 0 -0.08333 
-DEAL::-0.08333 0 -0.08333 -0.08333 0 0.3333 -0.08333 0 
-DEAL::-0.08333 -0.08333 0 -0.08333 0 -0.08333 0.3333 0 
-DEAL::-0.08333 -0.08333 -0.08333 0 -0.08333 0 0 0.3333 
diff --git a/tests/fe/cell_similarity_dgp_nonparametric_010.cc b/tests/fe/cell_similarity_dgp_nonparametric_010.cc
deleted file mode 100644 (file)
index 5496724..0000000
+++ /dev/null
@@ -1,174 +0,0 @@
-//----------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$ 
-//
-//    Copyright (C) 2009 by the deal.II authors
-//
-//    This file is subject to QPL and may not be  distributed
-//    without copyright and license information. Please refer
-//    to the file deal.II/doc/license.html for the  text  and
-//    further information on this license.
-//
-//----------------------------------------------------------------------
-
-
-// since early 2009, the FEValues objects try to be more efficient by only
-// recomputing things like gradients of shape functions if the cell on which
-// we are is not a translation of the previous one. in this series of tests we
-// make sure that this actually works the way it's supposed to be; in
-// particular, if we create a mesh of two identical cells but one has a curved
-// boundary, then they are the same if we use a Q1 mapping, but not a Q2
-// mapping. so we test that the mass matrix we get from each of these cells is
-// actually different in the latter case, but the same in the former
-//
-// the various tests cell_similarity_dgp_nonparametric_?? differ in the mappings and finite
-// elements in use
-
-
-#include "../tests.h"
-#include <base/logstream.h>
-#include <base/function.h>
-#include <base/quadrature_lib.h>
-#include <lac/vector.h>
-#include <grid/grid_generator.h>
-#include <grid/tria_boundary_lib.h>
-#include <dofs/dof_handler.h>
-#include <fe/fe_q.h>
-#include <fe/fe_dgp_nonparametric.h>
-#include <fe/fe_system.h>
-#include <fe/fe_values.h>
-#include <fe/mapping_q1.h>
-#include <fe/mapping_q.h>
-#include <fe/mapping_cartesian.h>
-
-#include <fstream>
-
-
-bool equal (const FullMatrix<double> &m1,
-           const FullMatrix<double> &m2)
-{
-  double d = 0, s = 0;
-  for (unsigned int i=0; i<m1.m(); ++i)
-    for (unsigned int j=0; j<m1.n(); ++j)
-      {
-       d += (m1(i,j)-m2(i,j)) * (m1(i,j)-m2(i,j));
-       s += m1(i,j) * m1(i,j);
-      }
-  return (d<1e-8*s);
-}
-
-
-template<int dim>
-void test (const Triangulation<dim>& tr)
-{
-  FE_DGPNonparametric<dim> fe(2);
-  deallog << "FE=" << fe.get_name() << std::endl;
-
-  MappingCartesian<dim> mapping;
-  deallog << "Mapping=Cartesian" << std::endl;
-
-  
-  DoFHandler<dim> dof(tr);
-  dof.distribute_dofs(fe);
-
-  const QGauss<dim> quadrature(2);
-  FEValues<dim> fe_values (mapping, fe, quadrature,
-                          update_values | update_gradients |
-                          update_JxW_values);
-
-  FullMatrix<double> mass_matrix[2], laplace_matrix[2];
-  mass_matrix[0].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  mass_matrix[1].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  laplace_matrix[0].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-  laplace_matrix[1].reinit(fe.dofs_per_cell, fe.dofs_per_cell);
-
-  for (typename DoFHandler<dim>::active_cell_iterator
-        cell = dof.begin_active();
-       cell != dof.end(); ++cell)
-    {
-      fe_values.reinit (cell);
-
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-         for (unsigned int q=0; q<fe_values.n_quadrature_points; ++q)
-           {
-             mass_matrix[cell->index()](i,j) += fe_values.shape_value (i,q) *
-                                                fe_values.shape_value (j,q) *
-                                                fe_values.JxW(q);
-             laplace_matrix[cell->index()](i,j) += fe_values.shape_grad (i,q) *
-                                                   fe_values.shape_grad (j,q) *
-                                                   fe_values.JxW(q);    
-           }
-    }
-
-                                  // check what we expect for this mapping
-                                  // about equality or inequality of the
-                                  // matrices
-  deallog << "Mass matrices "
-         << (equal (mass_matrix[0], mass_matrix[1]) ? "are" : "are not")
-         << " equal."
-         << std::endl;
-  deallog << "Laplace matrices "
-         << (equal (laplace_matrix[0], laplace_matrix[1]) ? "are" : "are not")
-         << " equal."
-         << std::endl;
-  
-  for (unsigned int cell=0; cell<2; ++cell)
-    {
-      deallog << "cell=" << cell << std::endl;
-      deallog << "mass_matrix:" << std::endl;
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       {
-         for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-           deallog << mass_matrix[cell](i,j) << ' ';
-         deallog << std::endl;
-       }
-      
-      deallog << "laplace_matrix:" << std::endl;
-      for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i)
-       {
-         for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
-           deallog << laplace_matrix[cell](i,j) << ' ';
-         deallog << std::endl;
-       }
-    }
-}
-
-
-
-template <int dim>
-void test()
-{
-  Triangulation<dim> tr;
-  Point<dim> p1 = Point<dim>();
-  Point<dim> p2 = (dim == 2 ?
-                  Point<dim>(2,1) :
-                  Point<dim>(2,1,1));
-  std::vector<unsigned int> subdivisions (dim, 1);
-  subdivisions[0] = 2;
-  GridGenerator::subdivided_hyper_rectangle(tr, subdivisions, p1, p2);
-
-  static const HyperBallBoundary<dim> boundary;
-  tr.set_boundary (1, boundary);
-
-                                  // set boundary id on cell 1
-  for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
-    if (tr.begin_active()->at_boundary(f))
-      tr.begin_active()->face(f)->set_boundary_indicator (1);
-  
-  test(tr);
-}
-
-
-int main()
-{
-  std::ofstream logfile ("cell_similarity_dgp_nonparametric_10/output");
-  deallog << std::setprecision (4);
-
-  deallog.attach(logfile);
-  deallog.depth_console (0);
-  deallog.threshold_double(1.e-7);
-
-  test<2>();
-  //test<3>();
-}
diff --git a/tests/fe/cell_similarity_dgp_nonparametric_010/cmp/generic b/tests/fe/cell_similarity_dgp_nonparametric_010/cmp/generic
deleted file mode 100644 (file)
index d4520f9..0000000
+++ /dev/null
@@ -1,69 +0,0 @@
-
-DEAL::FE=FE_Q<2>(1)
-DEAL::Mapping=Q2
-DEAL::Mass matrices are not equal.
-DEAL::Laplace matrices are not equal.
-DEAL::cell=0
-DEAL::mass_matrix:
-DEAL::0.2371 0.07167 0.06719 0.02582 
-DEAL::0.07167 0.04962 0.02582 0.03610 
-DEAL::0.06719 0.02582 0.03170 0.03162 
-DEAL::0.02582 0.03610 0.03162 0.09477 
-DEAL::laplace_matrix:
-DEAL::4.337 -0.2381 -2.153 -1.946 
-DEAL::-0.2381 0.9387 -0.5940 -0.1066 
-DEAL::-2.153 -0.5940 1.899 0.8483 
-DEAL::-1.946 -0.1066 0.8483 1.205 
-DEAL::cell=1
-DEAL::mass_matrix:
-DEAL::0.1111 0.05556 0.05556 0.02778 
-DEAL::0.05556 0.1111 0.02778 0.05556 
-DEAL::0.05556 0.02778 0.1111 0.05556 
-DEAL::0.02778 0.05556 0.05556 0.1111 
-DEAL::laplace_matrix:
-DEAL::0.6667 -0.1667 -0.1667 -0.3333 
-DEAL::-0.1667 0.6667 -0.3333 -0.1667 
-DEAL::-0.1667 -0.3333 0.6667 -0.1667 
-DEAL::-0.3333 -0.1667 -0.1667 0.6667 
-DEAL::FE=FE_Q<3>(1)
-DEAL::Mapping=Q2
-DEAL::Mass matrices are not equal.
-DEAL::Laplace matrices are not equal.
-DEAL::cell=0
-DEAL::mass_matrix:
-DEAL::0.07572 0.02718 0.02414 0.009471 0.02414 0.009471 0.008538 0.003898 
-DEAL::0.02718 0.03298 0.009471 0.01375 0.009471 0.01375 0.003898 0.007053 
-DEAL::0.02414 0.009471 0.02083 0.01071 0.008538 0.003898 0.01001 0.006119 
-DEAL::0.009471 0.01375 0.01071 0.02201 0.003898 0.007053 0.006119 0.01447 
-DEAL::0.02414 0.009471 0.008538 0.003898 0.02083 0.01071 0.01001 0.006119 
-DEAL::0.009471 0.01375 0.003898 0.007053 0.01071 0.02201 0.006119 0.01447 
-DEAL::0.008538 0.003898 0.01001 0.006119 0.01001 0.006119 0.01922 0.01377 
-DEAL::0.003898 0.007053 0.006119 0.01447 0.006119 0.01447 0.01377 0.03585 
-DEAL::laplace_matrix:
-DEAL::0.7840 0.04931 0.04652 -0.2138 0.04652 -0.2138 -0.2672 -0.2315 
-DEAL::0.04931 0.3584 -0.04035 -0.04210 -0.04035 -0.04210 -0.09114 -0.1517 
-DEAL::0.04652 -0.04035 0.2547 0.006678 -0.03606 -0.07879 -0.03423 -0.1051 
-DEAL::-0.2138 -0.04210 0.006678 0.3292 -0.07879 -0.05266 0.002197 0.06269 
-DEAL::0.04652 -0.04035 -0.03606 -0.07879 0.2547 0.006678 -0.03423 -0.1051 
-DEAL::-0.2138 -0.04210 -0.07879 -0.05266 0.006678 0.3292 0.002197 0.06269 
-DEAL::-0.2672 -0.09114 -0.03423 0.002197 -0.03423 0.002197 0.3052 0.1173 
-DEAL::-0.2315 -0.1517 -0.1051 0.06269 -0.1051 0.06269 0.1173 0.3509 
-DEAL::cell=1
-DEAL::mass_matrix:
-DEAL::0.03704 0.01852 0.01852 0.009259 0.01852 0.009259 0.009259 0.004630 
-DEAL::0.01852 0.03704 0.009259 0.01852 0.009259 0.01852 0.004630 0.009259 
-DEAL::0.01852 0.009259 0.03704 0.01852 0.009259 0.004630 0.01852 0.009259 
-DEAL::0.009259 0.01852 0.01852 0.03704 0.004630 0.009259 0.009259 0.01852 
-DEAL::0.01852 0.009259 0.009259 0.004630 0.03704 0.01852 0.01852 0.009259 
-DEAL::0.009259 0.01852 0.004630 0.009259 0.01852 0.03704 0.009259 0.01852 
-DEAL::0.009259 0.004630 0.01852 0.009259 0.01852 0.009259 0.03704 0.01852 
-DEAL::0.004630 0.009259 0.009259 0.01852 0.009259 0.01852 0.01852 0.03704 
-DEAL::laplace_matrix:
-DEAL::0.3333 0 0 -0.08333 0 -0.08333 -0.08333 -0.08333 
-DEAL::0 0.3333 -0.08333 0 -0.08333 0 -0.08333 -0.08333 
-DEAL::0 -0.08333 0.3333 0 -0.08333 -0.08333 0 -0.08333 
-DEAL::-0.08333 0 0 0.3333 -0.08333 -0.08333 -0.08333 0 
-DEAL::0 -0.08333 -0.08333 -0.08333 0.3333 0 0 -0.08333 
-DEAL::-0.08333 0 -0.08333 -0.08333 0 0.3333 -0.08333 0 
-DEAL::-0.08333 -0.08333 0 -0.08333 0 -0.08333 0.3333 0 
-DEAL::-0.08333 -0.08333 -0.08333 0 -0.08333 0 0 0.3333 

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.