]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename the class for P1NC element: FE_P1NCNonparametric -> FE_P1NC
authorJaeryun Yim <jaeryun.yim@gmail.com>
Thu, 14 Jul 2016 07:38:09 +0000 (16:38 +0900)
committerJaeryun Yim <jaeryun.yim@gmail.com>
Fri, 16 Sep 2016 12:07:24 +0000 (21:07 +0900)
+ Delete the class FE_P1NCParametric (header, source, tests)]

20 files changed:
tests/fe/p1nc_01.cc
tests/fe/p1nc_02.cc
tests/fe/p1nc_03.cc
tests/fe/p1nc_04.cc
tests/fe/p1nc_05.cc
tests/fe/p1nc_06.cc
tests/fe/p1nc_07.cc
tests/fe/p1nc_08.cc
tests/fe/p1nc_parametric_01.cc [deleted file]
tests/fe/p1nc_parametric_01.output [deleted file]
tests/fe/p1nc_parametric_02.cc [deleted file]
tests/fe/p1nc_parametric_02.output [deleted file]
tests/fe/p1nc_parametric_03.cc [deleted file]
tests/fe/p1nc_parametric_03.output [deleted file]
tests/fe/p1nc_parametric_04.cc [deleted file]
tests/fe/p1nc_parametric_04.output [deleted file]
tests/fe/p1nc_parametric_05.cc [deleted file]
tests/fe/p1nc_parametric_05.output [deleted file]
tests/fe/p1nc_parametric_06.cc [deleted file]
tests/fe/p1nc_parametric_06.output [deleted file]

index 357b1fd2e1307154efa4ddc5591f1e73ab97a2db..e1da4e4dadfd541c38e4337c562b46470791f135 100644 (file)
@@ -41,7 +41,7 @@ check()
   Triangulation<dim> triangulation;
   GridGenerator::hyper_cube (triangulation, 0, 5);
 
-  FE_P1NCNonparametric fe;
+  FE_P1NC fe;
   DoFHandler<dim> dof_handler (triangulation);
   dof_handler.distribute_dofs(fe);
 
index ad615aa6b51aeaba279af401b2064282c1d02abd..a3d49c3d56bdb8ba87efec290ce2ce49063665b7 100644 (file)
@@ -53,7 +53,7 @@ check()
   GridGenerator::hyper_cube (triangulation, 0., 5.);
   GridTools::transform (&stretch<dim>, triangulation) ;
 
-  FE_P1NCNonparametric fe;
+  FE_P1NC fe;
   DoFHandler<dim> dof_handler (triangulation);
   dof_handler.distribute_dofs(fe);
 
index 3856fc2fcf760e04854a006c46917a8571dfe303..f249a92a958acbc1c5273f1de8bb7bdd71a38824 100644 (file)
@@ -57,7 +57,7 @@ check()
   GridGenerator::hyper_cube (triangulation, 0., 1.);
   GridTools::transform (&affine<dim>, triangulation) ;
 
-  FE_P1NCNonparametric fe;
+  FE_P1NC fe;
   DoFHandler<dim> dof_handler (triangulation);
   dof_handler.distribute_dofs(fe);
 
index f6bcdc68e7f3a9c6440d5c0f95fc8e5f72ce436f..217e99462484dac96c339bc33d2f95a2239cfd42 100644 (file)
@@ -57,7 +57,7 @@ check()
   GridGenerator::hyper_cube (triangulation, 0., 1.);
   GridTools::transform (&bilinear<dim>, triangulation) ;
 
-  FE_P1NCNonparametric fe;
+  FE_P1NC fe;
   DoFHandler<dim> dof_handler (triangulation);
   dof_handler.distribute_dofs(fe);
 
index b1efa9058bd43332d5fd972684db52386a674719..93a041620f6c14fd42e8b4a8c15273d45c36ee2b 100644 (file)
@@ -41,7 +41,7 @@ check()
   Triangulation<dim> triangulation;
   GridGenerator::hyper_cube (triangulation, 0, 5);
 
-  FE_P1NCNonparametric fe;
+  FE_P1NC fe;
   DoFHandler<dim> dof_handler (triangulation);
   dof_handler.distribute_dofs(fe);
 
index da4d46b715973fa970b61fee862caf47e85179d0..46e9ba345d68386156b10e4d2092214741fb0d17 100644 (file)
@@ -53,7 +53,7 @@ check()
   GridGenerator::hyper_cube (triangulation, 0., 5.);
   GridTools::transform (&stretch<dim>, triangulation) ;
 
-  FE_P1NCNonparametric fe;
+  FE_P1NC fe;
   DoFHandler<dim> dof_handler (triangulation);
   dof_handler.distribute_dofs(fe);
 
index bdcdadfe8dd851ec24385f4d05a55aa62de92754..ad8f0c8efb0064e7f8ff327a97688def0bf4d77b 100644 (file)
@@ -57,7 +57,7 @@ check()
   GridGenerator::hyper_cube (triangulation, 0., 1.);
   GridTools::transform (&affine<dim>, triangulation) ;
 
-  FE_P1NCNonparametric fe;
+  FE_P1NC fe;
   DoFHandler<dim> dof_handler (triangulation);
   dof_handler.distribute_dofs(fe);
 
index 4a433771cb30c840817580514a45051311956c4e..22c6ddfafc471e5d0c66bf5ce943efefc5be1575 100644 (file)
@@ -57,7 +57,7 @@ check()
   GridGenerator::hyper_cube (triangulation, 0., 1.);
   GridTools::transform (&bilinear<dim>, triangulation) ;
 
-  FE_P1NCNonparametric fe;
+  FE_P1NC fe;
   DoFHandler<dim> dof_handler (triangulation);
   dof_handler.distribute_dofs(fe);
 
diff --git a/tests/fe/p1nc_parametric_01.cc b/tests/fe/p1nc_parametric_01.cc
deleted file mode 100644 (file)
index 436d30f..0000000
+++ /dev/null
@@ -1,77 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 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 the P1NC parametric element on a square
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_values.h>
-
-#include <deal.II/fe/fe_p1nc.h>
-
-#include <fstream>
-#include <string>
-
-#define PRECISION 5
-
-
-
-template<int dim>
-void
-check()
-{
-  Triangulation<dim> triangulation;
-  GridGenerator::hyper_cube (triangulation, 0, 5);
-
-  FE_P1NCParametric fe;
-  DoFHandler<dim> dof_handler (triangulation);
-  dof_handler.distribute_dofs(fe);
-
-  QGauss<dim> quadrature(3);
-  FEValues<dim> fe_values (fe, quadrature, update_values | update_q_points);
-  fe_values.reinit (dof_handler.begin_active());
-
-  for (unsigned int q=0; q<quadrature.size(); ++q)
-    {
-      deallog << "index=" << q
-              << " position=" << fe_values.quadrature_point(q)
-              << " values=";
-      for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
-        deallog << fe_values.shape_value(i,q) << ' ';
-      deallog << std::endl;
-    }
-}
-
-int
-main()
-{
-  std::ofstream logfile ("output");
-  deallog << std::setprecision(PRECISION);
-  deallog << std::fixed;
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  check<2>();
-}
-
-
-
diff --git a/tests/fe/p1nc_parametric_01.output b/tests/fe/p1nc_parametric_01.output
deleted file mode 100644 (file)
index 5436e9b..0000000
+++ /dev/null
@@ -1,10 +0,0 @@
-
-DEAL::index=0 position=0.56351 0.56351 values=0.63730 0.25000 0.25000 -0.13730 
-DEAL::index=1 position=2.50000 0.56351 values=0.44365 0.44365 0.05635 0.05635 
-DEAL::index=2 position=4.43649 0.56351 values=0.25000 0.63730 -0.13730 0.25000 
-DEAL::index=3 position=0.56351 2.50000 values=0.44365 0.05635 0.44365 0.05635 
-DEAL::index=4 position=2.50000 2.50000 values=0.25000 0.25000 0.25000 0.25000 
-DEAL::index=5 position=4.43649 2.50000 values=0.05635 0.44365 0.05635 0.44365 
-DEAL::index=6 position=0.56351 4.43649 values=0.25000 -0.13730 0.63730 0.25000 
-DEAL::index=7 position=2.50000 4.43649 values=0.05635 0.05635 0.44365 0.44365 
-DEAL::index=8 position=4.43649 4.43649 values=-0.13730 0.25000 0.25000 0.63730 
diff --git a/tests/fe/p1nc_parametric_02.cc b/tests/fe/p1nc_parametric_02.cc
deleted file mode 100644 (file)
index 32f1618..0000000
+++ /dev/null
@@ -1,89 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 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 the P1NC parametric element on a rectangle
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_tools.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_values.h>
-
-#include <deal.II/fe/fe_p1nc.h>
-
-#include <fstream>
-#include <string>
-
-#define PRECISION 5
-
-
-template<int dim>
-Point<dim> stretch (const Point<dim> &p)
-{
-  Point<dim> q = p ;
-  q(dim-1) *= 2. ;
-
-  return q ;
-}
-
-
-
-template<int dim>
-void
-check()
-{
-  Triangulation<dim> triangulation;
-  GridGenerator::hyper_cube (triangulation, 0., 5.);
-  GridTools::transform (&stretch<dim>, triangulation) ;
-
-  FE_P1NCParametric fe;
-  DoFHandler<dim> dof_handler (triangulation);
-  dof_handler.distribute_dofs(fe);
-
-  QGauss<dim> quadrature(3);
-  FEValues<dim> fe_values (fe, quadrature, update_values | update_q_points);
-  fe_values.reinit (dof_handler.begin_active());
-
-  for (unsigned int q=0; q<quadrature.size(); ++q)
-    {
-      deallog << "index=" << q
-              << " position=" << fe_values.quadrature_point(q)
-              << " values=";
-      for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
-        deallog << fe_values.shape_value(i,q) << ' ';
-      deallog << std::endl;
-    }
-}
-
-int
-main()
-{
-  std::ofstream logfile ("output");
-  deallog << std::setprecision(PRECISION);
-  deallog << std::fixed;
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  check<2>();
-}
-
-
-
diff --git a/tests/fe/p1nc_parametric_02.output b/tests/fe/p1nc_parametric_02.output
deleted file mode 100644 (file)
index 4d62e4c..0000000
+++ /dev/null
@@ -1,10 +0,0 @@
-
-DEAL::index=0 position=0.56351 1.12702 values=0.63730 0.25000 0.25000 -0.13730 
-DEAL::index=1 position=2.50000 1.12702 values=0.44365 0.44365 0.05635 0.05635 
-DEAL::index=2 position=4.43649 1.12702 values=0.25000 0.63730 -0.13730 0.25000 
-DEAL::index=3 position=0.56351 5.00000 values=0.44365 0.05635 0.44365 0.05635 
-DEAL::index=4 position=2.50000 5.00000 values=0.25000 0.25000 0.25000 0.25000 
-DEAL::index=5 position=4.43649 5.00000 values=0.05635 0.44365 0.05635 0.44365 
-DEAL::index=6 position=0.56351 8.87298 values=0.25000 -0.13730 0.63730 0.25000 
-DEAL::index=7 position=2.50000 8.87298 values=0.05635 0.05635 0.44365 0.44365 
-DEAL::index=8 position=4.43649 8.87298 values=-0.13730 0.25000 0.25000 0.63730 
diff --git a/tests/fe/p1nc_parametric_03.cc b/tests/fe/p1nc_parametric_03.cc
deleted file mode 100644 (file)
index f7ae39b..0000000
+++ /dev/null
@@ -1,93 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 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 the P1NC parametric element on a parallelogram
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_tools.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_values.h>
-
-#include <deal.II/fe/fe_p1nc.h>
-
-#include <fstream>
-#include <string>
-
-#define PRECISION 5
-
-
-template<int dim>
-Point<dim> affine (const Point<dim> &p)
-{
-  Point<dim> q = p ;
-  if (dim>=2)
-    {
-      q(0) = 2.*p(0) + p(1) ;
-      q(1) = p(0) + 3.*p(1) ;
-    }
-
-  return q ;
-}
-
-
-
-template<int dim>
-void
-check()
-{
-  Triangulation<dim> triangulation;
-  GridGenerator::hyper_cube (triangulation, 0., 1.);
-  GridTools::transform (&affine<dim>, triangulation) ;
-
-  FE_P1NCParametric fe;
-  DoFHandler<dim> dof_handler (triangulation);
-  dof_handler.distribute_dofs(fe);
-
-  QGauss<dim> quadrature(3);
-  FEValues<dim> fe_values (fe, quadrature, update_values | update_q_points);
-  fe_values.reinit (dof_handler.begin_active());
-
-  for (unsigned int q=0; q<quadrature.size(); ++q)
-    {
-      deallog << "index=" << q
-              << " position=" << fe_values.quadrature_point(q)
-              << " values=";
-      for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
-        deallog << fe_values.shape_value(i,q) << ' ';
-      deallog << std::endl;
-    }
-}
-
-int
-main()
-{
-  std::ofstream logfile ("output");
-  deallog << std::setprecision(PRECISION);
-  deallog << std::fixed;
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  check<2>();
-}
-
-
-
diff --git a/tests/fe/p1nc_parametric_03.output b/tests/fe/p1nc_parametric_03.output
deleted file mode 100644 (file)
index 4f8444a..0000000
+++ /dev/null
@@ -1,10 +0,0 @@
-
-DEAL::index=0 position=0.33810 0.45081 values=0.63730 0.25000 0.25000 -0.13730 
-DEAL::index=1 position=1.11270 0.83810 values=0.44365 0.44365 0.05635 0.05635 
-DEAL::index=2 position=1.88730 1.22540 values=0.25000 0.63730 -0.13730 0.25000 
-DEAL::index=3 position=0.72540 1.61270 values=0.44365 0.05635 0.44365 0.05635 
-DEAL::index=4 position=1.50000 2.00000 values=0.25000 0.25000 0.25000 0.25000 
-DEAL::index=5 position=2.27460 2.38730 values=0.05635 0.44365 0.05635 0.44365 
-DEAL::index=6 position=1.11270 2.77460 values=0.25000 -0.13730 0.63730 0.25000 
-DEAL::index=7 position=1.88730 3.16190 values=0.05635 0.05635 0.44365 0.44365 
-DEAL::index=8 position=2.66190 3.54919 values=-0.13730 0.25000 0.25000 0.63730 
diff --git a/tests/fe/p1nc_parametric_04.cc b/tests/fe/p1nc_parametric_04.cc
deleted file mode 100644 (file)
index 0773503..0000000
+++ /dev/null
@@ -1,77 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 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 the P1NC parametric element's gradient on a square
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_values.h>
-
-#include <deal.II/fe/fe_p1nc.h>
-
-#include <fstream>
-#include <string>
-
-#define PRECISION 5
-
-
-
-template<int dim>
-void
-check()
-{
-  Triangulation<dim> triangulation;
-  GridGenerator::hyper_cube (triangulation, 0, 5);
-
-  FE_P1NCParametric fe;
-  DoFHandler<dim> dof_handler (triangulation);
-  dof_handler.distribute_dofs(fe);
-
-  QGauss<dim> quadrature(3);
-  FEValues<dim> fe_values (fe, quadrature, update_gradients | update_q_points);
-  fe_values.reinit (dof_handler.begin_active());
-
-  for (unsigned int q=0; q<quadrature.size(); ++q)
-    {
-      deallog << "index=" << q
-              << " position=" << fe_values.quadrature_point(q)
-              << " values=";
-      for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
-        deallog << '[' << fe_values.shape_grad(i,q) << "] ";
-      deallog << std::endl;
-    }
-}
-
-int
-main()
-{
-  std::ofstream logfile ("output");
-  deallog << std::setprecision(PRECISION);
-  deallog << std::fixed;
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  check<2>();
-}
-
-
-
diff --git a/tests/fe/p1nc_parametric_04.output b/tests/fe/p1nc_parametric_04.output
deleted file mode 100644 (file)
index 51ce573..0000000
+++ /dev/null
@@ -1,10 +0,0 @@
-
-DEAL::index=0 position=0.56351 0.56351 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
-DEAL::index=1 position=2.50000 0.56351 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
-DEAL::index=2 position=4.43649 0.56351 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
-DEAL::index=3 position=0.56351 2.50000 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
-DEAL::index=4 position=2.50000 2.50000 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
-DEAL::index=5 position=4.43649 2.50000 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
-DEAL::index=6 position=0.56351 4.43649 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
-DEAL::index=7 position=2.50000 4.43649 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
-DEAL::index=8 position=4.43649 4.43649 values=[-0.10000 -0.10000] [0.10000 -0.10000] [-0.10000 0.10000] [0.10000 0.10000] 
diff --git a/tests/fe/p1nc_parametric_05.cc b/tests/fe/p1nc_parametric_05.cc
deleted file mode 100644 (file)
index 991ac01..0000000
+++ /dev/null
@@ -1,89 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 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 the P1NC parametric element's gradient on a rectangle
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_tools.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_values.h>
-
-#include <deal.II/fe/fe_p1nc.h>
-
-#include <fstream>
-#include <string>
-
-#define PRECISION 5
-
-
-template<int dim>
-Point<dim> stretch (const Point<dim> &p)
-{
-  Point<dim> q = p ;
-  q(dim-1) *= 2. ;
-
-  return q ;
-}
-
-
-
-template<int dim>
-void
-check()
-{
-  Triangulation<dim> triangulation;
-  GridGenerator::hyper_cube (triangulation, 0., 5.);
-  GridTools::transform (&stretch<dim>, triangulation) ;
-
-  FE_P1NCParametric fe;
-  DoFHandler<dim> dof_handler (triangulation);
-  dof_handler.distribute_dofs(fe);
-
-  QGauss<dim> quadrature(3);
-  FEValues<dim> fe_values (fe, quadrature, update_gradients | update_q_points);
-  fe_values.reinit (dof_handler.begin_active());
-
-  for (unsigned int q=0; q<quadrature.size(); ++q)
-    {
-      deallog << "index=" << q
-              << " position=" << fe_values.quadrature_point(q)
-              << " values=";
-      for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
-        deallog << '[' << fe_values.shape_grad(i,q) << "] ";
-      deallog << std::endl;
-    }
-}
-
-int
-main()
-{
-  std::ofstream logfile ("output");
-  deallog << std::setprecision(PRECISION);
-  deallog << std::fixed;
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  check<2>();
-}
-
-
-
diff --git a/tests/fe/p1nc_parametric_05.output b/tests/fe/p1nc_parametric_05.output
deleted file mode 100644 (file)
index 2d11da0..0000000
+++ /dev/null
@@ -1,10 +0,0 @@
-
-DEAL::index=0 position=0.56351 1.12702 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
-DEAL::index=1 position=2.50000 1.12702 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
-DEAL::index=2 position=4.43649 1.12702 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
-DEAL::index=3 position=0.56351 5.00000 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
-DEAL::index=4 position=2.50000 5.00000 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
-DEAL::index=5 position=4.43649 5.00000 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
-DEAL::index=6 position=0.56351 8.87298 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
-DEAL::index=7 position=2.50000 8.87298 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
-DEAL::index=8 position=4.43649 8.87298 values=[-0.10000 -0.05000] [0.10000 -0.05000] [-0.10000 0.05000] [0.10000 0.05000] 
diff --git a/tests/fe/p1nc_parametric_06.cc b/tests/fe/p1nc_parametric_06.cc
deleted file mode 100644 (file)
index 0d70de6..0000000
+++ /dev/null
@@ -1,93 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 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 the P1NC parametric element's gradient on a parallelogram
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_tools.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_values.h>
-
-#include <deal.II/fe/fe_p1nc.h>
-
-#include <fstream>
-#include <string>
-
-#define PRECISION 5
-
-
-template<int dim>
-Point<dim> affine (const Point<dim> &p)
-{
-  Point<dim> q = p ;
-  if (dim>=2)
-    {
-      q(0) = 2.*p(0) + p(1) ;
-      q(1) = p(0) + 3.*p(1) ;
-    }
-
-  return q ;
-}
-
-
-
-template<int dim>
-void
-check()
-{
-  Triangulation<dim> triangulation;
-  GridGenerator::hyper_cube (triangulation, 0., 1.);
-  GridTools::transform (&affine<dim>, triangulation) ;
-
-  FE_P1NCParametric fe;
-  DoFHandler<dim> dof_handler (triangulation);
-  dof_handler.distribute_dofs(fe);
-
-  QGauss<dim> quadrature(3);
-  FEValues<dim> fe_values (fe, quadrature, update_gradients | update_q_points);
-  fe_values.reinit (dof_handler.begin_active());
-
-  for (unsigned int q=0; q<quadrature.size(); ++q)
-    {
-      deallog << "index=" << q
-              << " position=" << fe_values.quadrature_point(q)
-              << " values=";
-      for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
-        deallog << '[' << fe_values.shape_grad(i,q) << "] ";
-      deallog << std::endl;
-    }
-}
-
-int
-main()
-{
-  std::ofstream logfile ("output");
-  deallog << std::setprecision(PRECISION);
-  deallog << std::fixed;
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  check<2>();
-}
-
-
-
diff --git a/tests/fe/p1nc_parametric_06.output b/tests/fe/p1nc_parametric_06.output
deleted file mode 100644 (file)
index d9f5209..0000000
+++ /dev/null
@@ -1,10 +0,0 @@
-
-DEAL::index=0 position=0.33810 0.45081 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 
-DEAL::index=1 position=1.11270 0.83810 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 
-DEAL::index=2 position=1.88730 1.22540 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 
-DEAL::index=3 position=0.72540 1.61270 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 
-DEAL::index=4 position=1.50000 2.00000 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 
-DEAL::index=5 position=2.27460 2.38730 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 
-DEAL::index=6 position=1.11270 2.77460 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 
-DEAL::index=7 position=1.88730 3.16190 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 
-DEAL::index=8 position=2.66190 3.54919 values=[-0.20000 -0.10000] [0.40000 -0.30000] [-0.40000 0.30000] [0.20000 0.10000] 

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.