]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Step one in breaking apart our monster testcase 'internals'. That testcase had an...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 14 Sep 2012 12:32:17 +0000 (12:32 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 14 Sep 2012 12:32:17 +0000 (12:32 +0000)
git-svn-id: https://svn.dealii.org/trunk@26376 0785d39b-7218-0410-832d-ea1e28bc413d

31 files changed:
tests/fe/fe_support_points_bdm.cc [new file with mode: 0644]
tests/fe/fe_support_points_bdm/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_common.h [new file with mode: 0644]
tests/fe/fe_support_points_nedelec.cc [new file with mode: 0644]
tests/fe/fe_support_points_nedelec/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_q.cc [new file with mode: 0644]
tests/fe/fe_support_points_q/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_q_hierarchical.cc [new file with mode: 0644]
tests/fe/fe_support_points_q_hierarchical/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_rt.cc [new file with mode: 0644]
tests/fe/fe_support_points_rt/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_01.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_01/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_02.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_02/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_03.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_03/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_04.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_04/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_05.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_05/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_06.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_06/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_07.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_07/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_08.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_08/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_09.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_09/cmp/generic [new file with mode: 0644]
tests/fe/fe_support_points_sys_10.cc [new file with mode: 0644]
tests/fe/fe_support_points_sys_10/cmp/generic [new file with mode: 0644]

diff --git a/tests/fe/fe_support_points_bdm.cc b/tests/fe/fe_support_points_bdm.cc
new file mode 100644 (file)
index 0000000..ec505ba
--- /dev/null
@@ -0,0 +1,29 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_ALL(BDM, 1, 2);
+  CHECK_ALL(BDM, 2, 2);
+}
diff --git a/tests/fe/fe_support_points_bdm/cmp/generic b/tests/fe/fe_support_points_bdm/cmp/generic
new file mode 100644 (file)
index 0000000..65f9349
--- /dev/null
@@ -0,0 +1,11 @@
+
+DEAL::BDM1<2> cell support points
+DEAL::BDM1<2> face 0 support points
+DEAL::BDM1<2> face 1 support points
+DEAL::BDM1<2> face 2 support points
+DEAL::BDM1<2> face 3 support points
+DEAL::BDM2<2> cell support points
+DEAL::BDM2<2> face 0 support points
+DEAL::BDM2<2> face 1 support points
+DEAL::BDM2<2> face 2 support points
+DEAL::BDM2<2> face 3 support points
diff --git a/tests/fe/fe_support_points_common.h b/tests/fe/fe_support_points_common.h
new file mode 100644 (file)
index 0000000..e5ff061
--- /dev/null
@@ -0,0 +1,82 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+
+#include "../tests.h"
+#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/base/qprojector.h>
+#include <deal.II/base/logstream.h>
+#include <deal.II/lac/vector.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_q_hierarchical.h>
+#include <deal.II/fe/fe_dgq.h>
+#include <deal.II/fe/fe_dgp.h>
+#include <deal.II/fe/fe_nedelec.h>
+#include <deal.II/fe/fe_bdm.h>
+#include <deal.II/fe/fe_raviart_thomas.h>
+#include <deal.II/fe/fe_system.h>
+#include <vector>
+#include <fstream>
+#include <iostream>
+#include <iomanip>
+#include <string>
+
+
+
+template <int dim>
+inline void
+check_support (const FiniteElement<dim>& finel, const char* name)
+{
+  Triangulation<dim> tr;
+  GridGenerator::hyper_cube(tr, 0., 1.);
+  DoFHandler<dim> dof (tr);
+  dof.distribute_dofs (finel);
+
+  deallog << name << '<' << dim << '>' << " cell support points" << std::endl;
+
+  const std::vector<Point<dim> > &cell_points = finel.get_unit_support_points ();
+
+  for (unsigned int k=0;k<cell_points.size();++k)
+    deallog << std::setprecision(3) << cell_points[k] << std::endl;
+
+  const std::vector<Point<dim-1> > &face_points = finel.get_unit_face_support_points ();
+  const std::vector<double> dummy_weights (face_points.size());
+
+  Quadrature<dim-1> q(face_points, dummy_weights);
+
+  for (unsigned int i=0;i<GeometryInfo<dim>::faces_per_cell;++i)
+    {
+      std::vector<Point<dim> > q_points (q.get_points().size());
+      QProjector<dim>::project_to_face (q, i, q_points);
+      Quadrature<dim> qp(q_points);
+      deallog << name << '<' << dim << '>' << " face " << i
+               << " support points" << std::endl;
+
+      for (unsigned int k=0; k<face_points.size(); ++k)
+       deallog << std::setprecision(3) << qp.point(k)
+               << std::endl;
+    }
+}
+
+
+#define CHECK_ALL(EL,deg,dim) { FE_ ## EL<dim> EL(deg); check_support(EL, #EL #deg); }
+#define CHECK_SYS1(sub1,N1,dim) { FESystem<dim> q(sub1, N1); check_support(q, #sub1 #N1); }
+#define CHECK_SYS2(sub1,N1,sub2,N2,dim) { FESystem<dim> q(sub1, N1, sub2, N2); \
+                                          check_support(q, #sub1 #N1 #sub2 #N2); }
+#define CHECK_SYS3(sub1,N1,sub2,N2,sub3,N3,dim) { FESystem<dim> q(sub1, N1, sub2, N2, sub3, N3); \
+                                          check_support(q, #sub1 #N1 #sub2 #N2 #sub3 #N3); }
+
+
diff --git a/tests/fe/fe_support_points_nedelec.cc b/tests/fe/fe_support_points_nedelec.cc
new file mode 100644 (file)
index 0000000..e7eef71
--- /dev/null
@@ -0,0 +1,31 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_ALL(Nedelec, 0, 2);
+  CHECK_ALL(Nedelec, 0, 3);
+  CHECK_ALL(Nedelec, 1, 2);
+  CHECK_ALL(Nedelec, 1, 3);
+}
diff --git a/tests/fe/fe_support_points_nedelec/cmp/generic b/tests/fe/fe_support_points_nedelec/cmp/generic
new file mode 100644 (file)
index 0000000..05ead30
--- /dev/null
@@ -0,0 +1,25 @@
+
+DEAL::Nedelec0<2> cell support points
+DEAL::Nedelec0<2> face 0 support points
+DEAL::Nedelec0<2> face 1 support points
+DEAL::Nedelec0<2> face 2 support points
+DEAL::Nedelec0<2> face 3 support points
+DEAL::Nedelec0<3> cell support points
+DEAL::Nedelec0<3> face 0 support points
+DEAL::Nedelec0<3> face 1 support points
+DEAL::Nedelec0<3> face 2 support points
+DEAL::Nedelec0<3> face 3 support points
+DEAL::Nedelec0<3> face 4 support points
+DEAL::Nedelec0<3> face 5 support points
+DEAL::Nedelec1<2> cell support points
+DEAL::Nedelec1<2> face 0 support points
+DEAL::Nedelec1<2> face 1 support points
+DEAL::Nedelec1<2> face 2 support points
+DEAL::Nedelec1<2> face 3 support points
+DEAL::Nedelec1<3> cell support points
+DEAL::Nedelec1<3> face 0 support points
+DEAL::Nedelec1<3> face 1 support points
+DEAL::Nedelec1<3> face 2 support points
+DEAL::Nedelec1<3> face 3 support points
+DEAL::Nedelec1<3> face 4 support points
+DEAL::Nedelec1<3> face 5 support points
diff --git a/tests/fe/fe_support_points_q.cc b/tests/fe/fe_support_points_q.cc
new file mode 100644 (file)
index 0000000..6818322
--- /dev/null
@@ -0,0 +1,33 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_ALL(Q,1,2);
+  CHECK_ALL(Q,2,2);
+  CHECK_ALL(Q,3,2);
+
+  CHECK_ALL(Q,1,3);
+  CHECK_ALL(Q,2,3);
+}
diff --git a/tests/fe/fe_support_points_q/cmp/generic b/tests/fe/fe_support_points_q/cmp/generic
new file mode 100644 (file)
index 0000000..ef1829c
--- /dev/null
@@ -0,0 +1,208 @@
+
+DEAL::Q1<2> cell support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::Q1<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::Q1<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::Q1<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::Q1<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::Q2<2> cell support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.500
+DEAL::1.00 0.500
+DEAL::0.500 0.00
+DEAL::0.500 1.00
+DEAL::0.500 0.500
+DEAL::Q2<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 0.500
+DEAL::Q2<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 0.500
+DEAL::Q2<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.500 0.00
+DEAL::Q2<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::0.500 1.00
+DEAL::Q3<2> cell support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.333
+DEAL::0.00 0.667
+DEAL::1.00 0.333
+DEAL::1.00 0.667
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::Q3<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 0.333
+DEAL::0.00 0.667
+DEAL::Q3<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 0.333
+DEAL::1.00 0.667
+DEAL::Q3<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::Q3<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::Q1<3> cell support points
+DEAL::0.00 0.00 0.00
+DEAL::1.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::Q1<3> face 0 support points
+DEAL::0.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::Q1<3> face 1 support points
+DEAL::1.00 0.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::1.00 0.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::Q1<3> face 2 support points
+DEAL::0.00 0.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 0.00
+DEAL::1.00 0.00 1.00
+DEAL::Q1<3> face 3 support points
+DEAL::0.00 1.00 0.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 0.00
+DEAL::1.00 1.00 1.00
+DEAL::Q1<3> face 4 support points
+DEAL::0.00 0.00 0.00
+DEAL::1.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::Q1<3> face 5 support points
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::Q2<3> cell support points
+DEAL::0.00 0.00 0.00
+DEAL::1.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::0.00 0.500 0.00
+DEAL::1.00 0.500 0.00
+DEAL::0.500 0.00 0.00
+DEAL::0.500 1.00 0.00
+DEAL::0.00 0.500 1.00
+DEAL::1.00 0.500 1.00
+DEAL::0.500 0.00 1.00
+DEAL::0.500 1.00 1.00
+DEAL::0.00 0.00 0.500
+DEAL::1.00 0.00 0.500
+DEAL::0.00 1.00 0.500
+DEAL::1.00 1.00 0.500
+DEAL::0.00 0.500 0.500
+DEAL::1.00 0.500 0.500
+DEAL::0.500 0.00 0.500
+DEAL::0.500 1.00 0.500
+DEAL::0.500 0.500 0.00
+DEAL::0.500 0.500 1.00
+DEAL::0.500 0.500 0.500
+DEAL::Q2<3> face 0 support points
+DEAL::0.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::0.00 0.00 0.500
+DEAL::0.00 1.00 0.500
+DEAL::0.00 0.500 0.00
+DEAL::0.00 0.500 1.00
+DEAL::0.00 0.500 0.500
+DEAL::Q2<3> face 1 support points
+DEAL::1.00 0.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::1.00 0.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::1.00 0.00 0.500
+DEAL::1.00 1.00 0.500
+DEAL::1.00 0.500 0.00
+DEAL::1.00 0.500 1.00
+DEAL::1.00 0.500 0.500
+DEAL::Q2<3> face 2 support points
+DEAL::0.00 0.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 0.00
+DEAL::1.00 0.00 1.00
+DEAL::0.500 0.00 0.00
+DEAL::0.500 0.00 1.00
+DEAL::0.00 0.00 0.500
+DEAL::1.00 0.00 0.500
+DEAL::0.500 0.00 0.500
+DEAL::Q2<3> face 3 support points
+DEAL::0.00 1.00 0.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 0.00
+DEAL::1.00 1.00 1.00
+DEAL::0.500 1.00 0.00
+DEAL::0.500 1.00 1.00
+DEAL::0.00 1.00 0.500
+DEAL::1.00 1.00 0.500
+DEAL::0.500 1.00 0.500
+DEAL::Q2<3> face 4 support points
+DEAL::0.00 0.00 0.00
+DEAL::1.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::0.00 0.500 0.00
+DEAL::1.00 0.500 0.00
+DEAL::0.500 0.00 0.00
+DEAL::0.500 1.00 0.00
+DEAL::0.500 0.500 0.00
+DEAL::Q2<3> face 5 support points
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::0.00 0.500 1.00
+DEAL::1.00 0.500 1.00
+DEAL::0.500 0.00 1.00
+DEAL::0.500 1.00 1.00
+DEAL::0.500 0.500 1.00
diff --git a/tests/fe/fe_support_points_q_hierarchical.cc b/tests/fe/fe_support_points_q_hierarchical.cc
new file mode 100644 (file)
index 0000000..cc26fff
--- /dev/null
@@ -0,0 +1,32 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_ALL(Q_Hierarchical,1,2);
+  CHECK_ALL(Q_Hierarchical,2,2);
+  CHECK_ALL(Q_Hierarchical,3,2);
+  CHECK_ALL(Q_Hierarchical,1,3);
+  CHECK_ALL(Q_Hierarchical,2,3);
+}
diff --git a/tests/fe/fe_support_points_q_hierarchical/cmp/generic b/tests/fe/fe_support_points_q_hierarchical/cmp/generic
new file mode 100644 (file)
index 0000000..a240ce5
--- /dev/null
@@ -0,0 +1,208 @@
+
+DEAL::Q_Hierarchical1<2> cell support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::Q_Hierarchical1<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::Q_Hierarchical1<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::Q_Hierarchical1<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::Q_Hierarchical1<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::Q_Hierarchical2<2> cell support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.500
+DEAL::1.00 0.500
+DEAL::0.500 0.00
+DEAL::0.500 1.00
+DEAL::0.500 0.500
+DEAL::Q_Hierarchical2<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 0.500
+DEAL::Q_Hierarchical2<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 0.500
+DEAL::Q_Hierarchical2<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.500 0.00
+DEAL::Q_Hierarchical2<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::0.500 1.00
+DEAL::Q_Hierarchical3<2> cell support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::Q_Hierarchical3<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::Q_Hierarchical3<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::Q_Hierarchical3<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::Q_Hierarchical3<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::Q_Hierarchical1<3> cell support points
+DEAL::0.00 0.00 0.00
+DEAL::1.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::Q_Hierarchical1<3> face 0 support points
+DEAL::0.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::Q_Hierarchical1<3> face 1 support points
+DEAL::1.00 0.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::1.00 0.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::Q_Hierarchical1<3> face 2 support points
+DEAL::0.00 0.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 0.00
+DEAL::1.00 0.00 1.00
+DEAL::Q_Hierarchical1<3> face 3 support points
+DEAL::0.00 1.00 0.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 0.00
+DEAL::1.00 1.00 1.00
+DEAL::Q_Hierarchical1<3> face 4 support points
+DEAL::0.00 0.00 0.00
+DEAL::1.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::Q_Hierarchical1<3> face 5 support points
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::Q_Hierarchical2<3> cell support points
+DEAL::0.00 0.00 0.00
+DEAL::1.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::0.00 0.500 0.00
+DEAL::1.00 0.500 0.00
+DEAL::0.500 0.00 0.00
+DEAL::0.500 1.00 0.00
+DEAL::0.00 0.500 1.00
+DEAL::1.00 0.500 1.00
+DEAL::0.500 0.00 1.00
+DEAL::0.500 1.00 1.00
+DEAL::0.00 0.00 0.500
+DEAL::1.00 0.00 0.500
+DEAL::0.00 1.00 0.500
+DEAL::1.00 1.00 0.500
+DEAL::0.00 0.500 0.500
+DEAL::1.00 0.500 0.500
+DEAL::0.500 0.00 0.500
+DEAL::0.500 1.00 0.500
+DEAL::0.500 0.500 0.00
+DEAL::0.500 0.500 1.00
+DEAL::0.500 0.500 0.500
+DEAL::Q_Hierarchical2<3> face 0 support points
+DEAL::0.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::0.00 0.00 0.500
+DEAL::0.00 1.00 0.500
+DEAL::0.00 0.500 0.00
+DEAL::0.00 0.500 1.00
+DEAL::0.00 0.500 0.500
+DEAL::Q_Hierarchical2<3> face 1 support points
+DEAL::1.00 0.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::1.00 0.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::1.00 0.00 0.500
+DEAL::1.00 1.00 0.500
+DEAL::1.00 0.500 0.00
+DEAL::1.00 0.500 1.00
+DEAL::1.00 0.500 0.500
+DEAL::Q_Hierarchical2<3> face 2 support points
+DEAL::0.00 0.00 0.00
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 0.00
+DEAL::1.00 0.00 1.00
+DEAL::0.500 0.00 0.00
+DEAL::0.500 0.00 1.00
+DEAL::0.00 0.00 0.500
+DEAL::1.00 0.00 0.500
+DEAL::0.500 0.00 0.500
+DEAL::Q_Hierarchical2<3> face 3 support points
+DEAL::0.00 1.00 0.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 0.00
+DEAL::1.00 1.00 1.00
+DEAL::0.500 1.00 0.00
+DEAL::0.500 1.00 1.00
+DEAL::0.00 1.00 0.500
+DEAL::1.00 1.00 0.500
+DEAL::0.500 1.00 0.500
+DEAL::Q_Hierarchical2<3> face 4 support points
+DEAL::0.00 0.00 0.00
+DEAL::1.00 0.00 0.00
+DEAL::0.00 1.00 0.00
+DEAL::1.00 1.00 0.00
+DEAL::0.00 0.500 0.00
+DEAL::1.00 0.500 0.00
+DEAL::0.500 0.00 0.00
+DEAL::0.500 1.00 0.00
+DEAL::0.500 0.500 0.00
+DEAL::Q_Hierarchical2<3> face 5 support points
+DEAL::0.00 0.00 1.00
+DEAL::1.00 0.00 1.00
+DEAL::0.00 1.00 1.00
+DEAL::1.00 1.00 1.00
+DEAL::0.00 0.500 1.00
+DEAL::1.00 0.500 1.00
+DEAL::0.500 0.00 1.00
+DEAL::0.500 1.00 1.00
+DEAL::0.500 0.500 1.00
diff --git a/tests/fe/fe_support_points_rt.cc b/tests/fe/fe_support_points_rt.cc
new file mode 100644 (file)
index 0000000..dbc6807
--- /dev/null
@@ -0,0 +1,31 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_ALL(RaviartThomas, 0, 2);
+  CHECK_ALL(RaviartThomas, 0, 3);
+  CHECK_ALL(RaviartThomas, 1, 2);
+  CHECK_ALL(RaviartThomas, 1, 3);
+}
diff --git a/tests/fe/fe_support_points_rt/cmp/generic b/tests/fe/fe_support_points_rt/cmp/generic
new file mode 100644 (file)
index 0000000..a60ccf5
--- /dev/null
@@ -0,0 +1,25 @@
+
+DEAL::RaviartThomas0<2> cell support points
+DEAL::RaviartThomas0<2> face 0 support points
+DEAL::RaviartThomas0<2> face 1 support points
+DEAL::RaviartThomas0<2> face 2 support points
+DEAL::RaviartThomas0<2> face 3 support points
+DEAL::RaviartThomas0<3> cell support points
+DEAL::RaviartThomas0<3> face 0 support points
+DEAL::RaviartThomas0<3> face 1 support points
+DEAL::RaviartThomas0<3> face 2 support points
+DEAL::RaviartThomas0<3> face 3 support points
+DEAL::RaviartThomas0<3> face 4 support points
+DEAL::RaviartThomas0<3> face 5 support points
+DEAL::RaviartThomas1<2> cell support points
+DEAL::RaviartThomas1<2> face 0 support points
+DEAL::RaviartThomas1<2> face 1 support points
+DEAL::RaviartThomas1<2> face 2 support points
+DEAL::RaviartThomas1<2> face 3 support points
+DEAL::RaviartThomas1<3> cell support points
+DEAL::RaviartThomas1<3> face 0 support points
+DEAL::RaviartThomas1<3> face 1 support points
+DEAL::RaviartThomas1<3> face 2 support points
+DEAL::RaviartThomas1<3> face 3 support points
+DEAL::RaviartThomas1<3> face 4 support points
+DEAL::RaviartThomas1<3> face 5 support points
diff --git a/tests/fe/fe_support_points_sys_01.cc b/tests/fe/fe_support_points_sys_01.cc
new file mode 100644 (file)
index 0000000..cec4ebc
--- /dev/null
@@ -0,0 +1,28 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS1(FE_Q<2>(1),3,2);
+}
diff --git a/tests/fe/fe_support_points_sys_01/cmp/generic b/tests/fe/fe_support_points_sys_01/cmp/generic
new file mode 100644 (file)
index 0000000..514de0a
--- /dev/null
@@ -0,0 +1,42 @@
+
+DEAL::FE_Q<2>(1)3<2> cell support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::FE_Q<2>(1)3<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::FE_Q<2>(1)3<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::FE_Q<2>(1)3<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::FE_Q<2>(1)3<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
diff --git a/tests/fe/fe_support_points_sys_02.cc b/tests/fe/fe_support_points_sys_02.cc
new file mode 100644 (file)
index 0000000..ba270a8
--- /dev/null
@@ -0,0 +1,28 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS1(FE_DGQ<2>(2),2,2);
+}
diff --git a/tests/fe/fe_support_points_sys_02/cmp/generic b/tests/fe/fe_support_points_sys_02/cmp/generic
new file mode 100644 (file)
index 0000000..c5ff501
--- /dev/null
@@ -0,0 +1,24 @@
+
+DEAL::FE_DGQ<2>(2)2<2> cell support points
+DEAL::0.00 0.00
+DEAL::0.500 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.500
+DEAL::0.500 0.500
+DEAL::1.00 0.500
+DEAL::0.00 1.00
+DEAL::0.500 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.500 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.500
+DEAL::0.500 0.500
+DEAL::1.00 0.500
+DEAL::0.00 1.00
+DEAL::0.500 1.00
+DEAL::1.00 1.00
+DEAL::FE_DGQ<2>(2)2<2> face 0 support points
+DEAL::FE_DGQ<2>(2)2<2> face 1 support points
+DEAL::FE_DGQ<2>(2)2<2> face 2 support points
+DEAL::FE_DGQ<2>(2)2<2> face 3 support points
diff --git a/tests/fe/fe_support_points_sys_03.cc b/tests/fe/fe_support_points_sys_03.cc
new file mode 100644 (file)
index 0000000..716ddc7
--- /dev/null
@@ -0,0 +1,28 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS2(FE_Q<2>(1),3,FE_DGQ<2>(2),2,2);
+}
diff --git a/tests/fe/fe_support_points_sys_03/cmp/generic b/tests/fe/fe_support_points_sys_03/cmp/generic
new file mode 100644 (file)
index 0000000..ec8e668
--- /dev/null
@@ -0,0 +1,60 @@
+
+DEAL::FE_Q<2>(1)3FE_DGQ<2>(2)2<2> cell support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.500 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.500
+DEAL::0.500 0.500
+DEAL::1.00 0.500
+DEAL::0.00 1.00
+DEAL::0.500 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.500 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.500
+DEAL::0.500 0.500
+DEAL::1.00 0.500
+DEAL::0.00 1.00
+DEAL::0.500 1.00
+DEAL::1.00 1.00
+DEAL::FE_Q<2>(1)3FE_DGQ<2>(2)2<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::FE_Q<2>(1)3FE_DGQ<2>(2)2<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::FE_Q<2>(1)3FE_DGQ<2>(2)2<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::FE_Q<2>(1)3FE_DGQ<2>(2)2<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
diff --git a/tests/fe/fe_support_points_sys_04.cc b/tests/fe/fe_support_points_sys_04.cc
new file mode 100644 (file)
index 0000000..46858df
--- /dev/null
@@ -0,0 +1,28 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS3(FE_DGQ<2>(2),2,FE_DGQ<2>(2),2,FE_Q<2>(3),3,2);
+}
diff --git a/tests/fe/fe_support_points_sys_04/cmp/generic b/tests/fe/fe_support_points_sys_04/cmp/generic
new file mode 100644 (file)
index 0000000..1f19a2c
--- /dev/null
@@ -0,0 +1,138 @@
+
+DEAL::FE_DGQ<2>(2)2FE_DGQ<2>(2)2FE_Q<2>(3)3<2> cell support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.333
+DEAL::0.00 0.667
+DEAL::0.00 0.333
+DEAL::0.00 0.667
+DEAL::0.00 0.333
+DEAL::0.00 0.667
+DEAL::1.00 0.333
+DEAL::1.00 0.667
+DEAL::1.00 0.333
+DEAL::1.00 0.667
+DEAL::1.00 0.333
+DEAL::1.00 0.667
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::0.00 0.00
+DEAL::0.500 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.500
+DEAL::0.500 0.500
+DEAL::1.00 0.500
+DEAL::0.00 1.00
+DEAL::0.500 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.500 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.500
+DEAL::0.500 0.500
+DEAL::1.00 0.500
+DEAL::0.00 1.00
+DEAL::0.500 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.500 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.500
+DEAL::0.500 0.500
+DEAL::1.00 0.500
+DEAL::0.00 1.00
+DEAL::0.500 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.500 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.500
+DEAL::0.500 0.500
+DEAL::1.00 0.500
+DEAL::0.00 1.00
+DEAL::0.500 1.00
+DEAL::1.00 1.00
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::FE_DGQ<2>(2)2FE_DGQ<2>(2)2FE_Q<2>(3)3<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 0.333
+DEAL::0.00 0.667
+DEAL::0.00 0.333
+DEAL::0.00 0.667
+DEAL::0.00 0.333
+DEAL::0.00 0.667
+DEAL::FE_DGQ<2>(2)2FE_DGQ<2>(2)2FE_Q<2>(3)3<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 0.333
+DEAL::1.00 0.667
+DEAL::1.00 0.333
+DEAL::1.00 0.667
+DEAL::1.00 0.333
+DEAL::1.00 0.667
+DEAL::FE_DGQ<2>(2)2FE_DGQ<2>(2)2FE_Q<2>(3)3<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::FE_DGQ<2>(2)2FE_DGQ<2>(2)2FE_Q<2>(3)3<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
diff --git a/tests/fe/fe_support_points_sys_05.cc b/tests/fe/fe_support_points_sys_05.cc
new file mode 100644 (file)
index 0000000..36f173e
--- /dev/null
@@ -0,0 +1,31 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS3((FESystem<2>(FE_Q<2>(1),3)), 3,
+            FE_DGQ<2>(3), 1,
+            FE_Q<2>(1), 3,
+            2);
+}
diff --git a/tests/fe/fe_support_points_sys_05/cmp/generic b/tests/fe/fe_support_points_sys_05/cmp/generic
new file mode 100644 (file)
index 0000000..53fbc31
--- /dev/null
@@ -0,0 +1,166 @@
+
+DEAL::(FESystem<2>(FE_Q<2>(1),3))3FE_DGQ<2>(3)1FE_Q<2>(1)3<2> cell support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.333
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::1.00 0.333
+DEAL::0.00 0.667
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::1.00 0.667
+DEAL::0.00 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::1.00 1.00
+DEAL::(FESystem<2>(FE_Q<2>(1),3))3FE_DGQ<2>(3)1FE_Q<2>(1)3<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::(FESystem<2>(FE_Q<2>(1),3))3FE_DGQ<2>(3)1FE_Q<2>(1)3<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::(FESystem<2>(FE_Q<2>(1),3))3FE_DGQ<2>(3)1FE_Q<2>(1)3<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::(FESystem<2>(FE_Q<2>(1),3))3FE_DGQ<2>(3)1FE_Q<2>(1)3<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
diff --git a/tests/fe/fe_support_points_sys_06.cc b/tests/fe/fe_support_points_sys_06.cc
new file mode 100644 (file)
index 0000000..38f1205
--- /dev/null
@@ -0,0 +1,32 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS3(FE_DGQ<2>(3), 1,
+            FESystem<2>(FE_DGQ<2>(3),3), 1,
+            FESystem<2>(FE_Q<2>(2),3,
+                        FE_DGQ<2>(0),1),2,
+            2);
+}
diff --git a/tests/fe/fe_support_points_sys_06/cmp/generic b/tests/fe/fe_support_points_sys_06/cmp/generic
new file mode 100644 (file)
index 0000000..18ae3cd
--- /dev/null
@@ -0,0 +1,198 @@
+
+DEAL::FE_DGQ<2>(3)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_DGQ<2>(0),1)2<2> cell support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.00 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.333
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::1.00 0.333
+DEAL::0.00 0.667
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::1.00 0.667
+DEAL::0.00 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.333
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::1.00 0.333
+DEAL::0.00 0.667
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::1.00 0.667
+DEAL::0.00 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.333
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::1.00 0.333
+DEAL::0.00 0.667
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::1.00 0.667
+DEAL::0.00 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::1.00 1.00
+DEAL::0.00 0.00
+DEAL::0.333 0.00
+DEAL::0.667 0.00
+DEAL::1.00 0.00
+DEAL::0.00 0.333
+DEAL::0.333 0.333
+DEAL::0.667 0.333
+DEAL::1.00 0.333
+DEAL::0.00 0.667
+DEAL::0.333 0.667
+DEAL::0.667 0.667
+DEAL::1.00 0.667
+DEAL::0.00 1.00
+DEAL::0.333 1.00
+DEAL::0.667 1.00
+DEAL::1.00 1.00
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::0.500 0.500
+DEAL::FE_DGQ<2>(3)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_DGQ<2>(0),1)2<2> face 0 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::0.00 0.500
+DEAL::FE_DGQ<2>(3)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_DGQ<2>(0),1)2<2> face 1 support points
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::1.00 0.500
+DEAL::FE_DGQ<2>(3)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_DGQ<2>(0),1)2<2> face 2 support points
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::0.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::1.00 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::0.500 0.00
+DEAL::FE_DGQ<2>(3)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_DGQ<2>(0),1)2<2> face 3 support points
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::0.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::1.00 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
+DEAL::0.500 1.00
diff --git a/tests/fe/fe_support_points_sys_07.cc b/tests/fe/fe_support_points_sys_07.cc
new file mode 100644 (file)
index 0000000..efad599
--- /dev/null
@@ -0,0 +1,30 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS2 (FE_DGQ<2>(3), 1,
+              FE_Nedelec<2>(0), 2,
+              2);
+}
diff --git a/tests/fe/fe_support_points_sys_07/cmp/generic b/tests/fe/fe_support_points_sys_07/cmp/generic
new file mode 100644 (file)
index 0000000..e6140c4
--- /dev/null
@@ -0,0 +1,6 @@
+
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(0)2<2> cell support points
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(0)2<2> face 0 support points
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(0)2<2> face 1 support points
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(0)2<2> face 2 support points
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(0)2<2> face 3 support points
diff --git a/tests/fe/fe_support_points_sys_08.cc b/tests/fe/fe_support_points_sys_08.cc
new file mode 100644 (file)
index 0000000..6f0b7f6
--- /dev/null
@@ -0,0 +1,32 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS3(FE_Nedelec<2>(0), 1,
+            FESystem<2>(FE_DGQ<2>(3),3), 1,
+            FESystem<2>(FE_Q<2>(2),3,
+                        FE_Nedelec<2>(0),2),2,
+            2);
+}
diff --git a/tests/fe/fe_support_points_sys_08/cmp/generic b/tests/fe/fe_support_points_sys_08/cmp/generic
new file mode 100644 (file)
index 0000000..8ef502f
--- /dev/null
@@ -0,0 +1,6 @@
+
+DEAL::FE_Nedelec<2>(0)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(0),2)2<2> cell support points
+DEAL::FE_Nedelec<2>(0)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(0),2)2<2> face 0 support points
+DEAL::FE_Nedelec<2>(0)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(0),2)2<2> face 1 support points
+DEAL::FE_Nedelec<2>(0)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(0),2)2<2> face 2 support points
+DEAL::FE_Nedelec<2>(0)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(0),2)2<2> face 3 support points
diff --git a/tests/fe/fe_support_points_sys_09.cc b/tests/fe/fe_support_points_sys_09.cc
new file mode 100644 (file)
index 0000000..5bb2e9c
--- /dev/null
@@ -0,0 +1,30 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS2 (FE_DGQ<2>(3), 1,
+              FE_Nedelec<2>(1), 2,
+              2);
+}
diff --git a/tests/fe/fe_support_points_sys_09/cmp/generic b/tests/fe/fe_support_points_sys_09/cmp/generic
new file mode 100644 (file)
index 0000000..8518f8d
--- /dev/null
@@ -0,0 +1,6 @@
+
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(1)2<2> cell support points
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(1)2<2> face 0 support points
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(1)2<2> face 1 support points
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(1)2<2> face 2 support points
+DEAL::FE_DGQ<2>(3)1FE_Nedelec<2>(1)2<2> face 3 support points
diff --git a/tests/fe/fe_support_points_sys_10.cc b/tests/fe/fe_support_points_sys_10.cc
new file mode 100644 (file)
index 0000000..4ff239f
--- /dev/null
@@ -0,0 +1,31 @@
+//----------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2007, 2008, 2010, 2012 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.
+//
+//----------------------------------------------------------------------
+//
+// Compute support points
+
+#include "../tests.h"
+#include "fe_support_points_common.h"
+
+
+int
+main()
+{
+  initlog(__FILE__);
+  deallog.threshold_double(1.e-10);
+
+  CHECK_SYS3(FE_Nedelec<2>(1), 1,
+            FESystem<2>(FE_DGQ<2>(3),3), 1,
+            FESystem<2>(FE_Q<2>(2),3,
+                        FE_Nedelec<2>(1),2),2,
+            2);
+}
diff --git a/tests/fe/fe_support_points_sys_10/cmp/generic b/tests/fe/fe_support_points_sys_10/cmp/generic
new file mode 100644 (file)
index 0000000..05fbb0a
--- /dev/null
@@ -0,0 +1,6 @@
+
+DEAL::FE_Nedelec<2>(1)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(1),2)2<2> cell support points
+DEAL::FE_Nedelec<2>(1)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(1),2)2<2> face 0 support points
+DEAL::FE_Nedelec<2>(1)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(1),2)2<2> face 1 support points
+DEAL::FE_Nedelec<2>(1)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(1),2)2<2> face 2 support points
+DEAL::FE_Nedelec<2>(1)1FESystem<2>(FE_DGQ<2>(3),3)1FESystem<2>(FE_Q<2>(2),3, FE_Nedelec<2>(1),2)2<2> face 3 support points

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.