From: bangerth Date: Fri, 15 Dec 2006 20:52:14 +0000 (+0000) Subject: A bunch of new tests that check whether h, p and hp constraints generated for a simpl... X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=a682045cd578aa85d46516cc2fa340cb7db07fef;p=dealii-svn.git A bunch of new tests that check whether h, p and hp constraints generated for a simple mesh make sense, by checking that if we interpolate a function of suitable polynomial degree onto this mesh, that the constraints are an identity operation. git-svn-id: https://svn.dealii.org/trunk@14257 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/hp/hp_constraints_common.h b/tests/hp/hp_constraints_common.h index fd8038f99c..6c38ac59a3 100644 --- a/tests/hp/hp_constraints_common.h +++ b/tests/hp/hp_constraints_common.h @@ -16,6 +16,7 @@ #include "../tests.h" #include +#include #include #include #include @@ -41,6 +42,7 @@ #include #include #include +#include #include #include @@ -255,6 +257,159 @@ void test_with_2d_deformed_refined_mesh (const hp::FECollection &fe) +// test that interpolating a suitable polynomial onto a refined mesh (which +// should yield zero error) and then applying constraints still yields zero +// error. we do so with every pair of finite elements given +template +void test_interpolation_base (const hp::FECollection &fe, + const std::vector &polynomial_degrees, + const bool do_refine) +{ + // create a mesh like this (viewed + // from top, if in 3d): + // *---*---* + // | 0 | 1 | + // *---*---* + // + // then refine cell 1 if do_refine, so that + // we get hanging nodes + Triangulation triangulation; + std::vector subdivisions (dim, 1); + subdivisions[0] = 2; + GridGenerator::subdivided_hyper_rectangle (triangulation, subdivisions, + Point(), + (dim == 3 ? + Point(2,1,1) : + (dim == 2 ? + Point(2,1) : + Point(2.)))); + + if (do_refine) + { + (++triangulation.begin_active())->set_refine_flag (); + triangulation.execute_coarsening_and_refinement (); + } + + hp::DoFHandler dof_handler(triangulation); + + + // for every pair of finite elements, + // assign them to each of the two sides of the domain + for (unsigned int fe1=0; fe1::active_cell_iterator + cell = dof_handler.begin_active(); + cell->set_active_fe_index (fe1); + ++cell; + + for (; cell != dof_handler.end(); ++cell) + cell->set_active_fe_index (fe2); + + dof_handler.distribute_dofs (fe); + + ConstraintMatrix constraints; + DoFTools::make_hanging_node_constraints (dof_handler, + constraints); + constraints.close (); + + Vector interpolant_1 (dof_handler.n_dofs()); + Vector interpolant_2 (dof_handler.n_dofs()); + + Vector error (triangulation.n_active_cells()); + + // now consider the dim polynomials + // of degree equal to the minimal + // degree of the two finite elements + // with dependence on only a single + // coordinate. also consider the one + // that has full degree in all + // directions (note that the last + // test will fail for P finite + // elements, whereas it is ok for the + // Q elements; the P elements don't + // run this test right now because + // they have no support points and + // therefore can't use + // VectorTools::interpolate...) + const unsigned int min_degree = std::min (polynomial_degrees[fe1], + polynomial_degrees[fe2]); + for (unsigned int test=0; test exponents; + if (test < dim) + exponents[test] = min_degree; + else + { + for (unsigned int i=0; i test_function (exponents, + fe.n_components()); + + // interpolate the function + VectorTools::interpolate (dof_handler, + test_function, + interpolant_1); + + // then compute the interpolation error + VectorTools::integrate_difference (dof_handler, + interpolant_1, + test_function, + error, + hp::QCollection(QGauss(min_degree+2)), + VectorTools::L2_norm); + Assert (error.l2_norm() < 1e-12*interpolant_1.l2_norm(), + ExcInternalError()); + deallog << " Relative interpolation error before constraints: " + << error.l2_norm() / interpolant_1.l2_norm() + << std::endl; + + // copy the interpolant, apply + // the constraints, and then + // compare the difference. it + // should be zero, since our + // original polynomial was in the + // ansatz space + interpolant_2 = interpolant_1; + constraints.distribute (interpolant_2); + + interpolant_2 -= interpolant_1; + + Assert (interpolant_2.l2_norm() < 1e-12*interpolant_1.l2_norm(), + ExcInternalError()); + + deallog << " Relative difference after constraints: " + << interpolant_2.l2_norm() / interpolant_1.l2_norm() + << std::endl; + } + } +} + + +template +void test_interpolation (const hp::FECollection &fe, + const std::vector &polynomial_degrees) +{ + test_interpolation_base (fe, polynomial_degrees, false); + test_interpolation_base (fe, polynomial_degrees, true); +} + + + int main () { std::ofstream logfile(logname); diff --git a/tests/hp/hp_constraints_dgp_06.cc b/tests/hp/hp_constraints_dgp_06.cc new file mode 100644 index 0000000000..b84b3fd0a1 --- /dev/null +++ b/tests/hp/hp_constraints_dgp_06.cc @@ -0,0 +1,40 @@ +//---------------------------- hp_constraints_dgp_06.cc --------------------------- +// $Id: hp_constraints_dgp_06.cc 12732 2006-03-28 23:15:45Z wolf $ +// Version: $Name$ +// +// Copyright (C) 2006 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. +// +//---------------------------- hp_constraints_dgp_06.cc --------------------------- + + +// check that computation of hp constraints works for DGP elements correctly + +// note that for mapped DGP(k) spaces, P(k) is not in the range of the +// mapping. However, P(k/2) is. Therefore, we have a gap for +// convergence, which we have to specify in the last argument to the +// call below + +char logname[] = "hp_constraints_dgp_06/output"; + + +#include "hp_constraints_common.h" + + +template +void test () +{ + hp::FECollection fe; + std::vector degrees; + for (unsigned int i=0; i<7-dim; ++i) + { + fe.push_back (FE_DGP(i)); + degrees.push_back (i); + } + + test_interpolation (fe, degrees); +} diff --git a/tests/hp/hp_constraints_dgp_06/cmp/generic b/tests/hp/hp_constraints_dgp_06/cmp/generic new file mode 100644 index 0000000000..8b13789179 --- /dev/null +++ b/tests/hp/hp_constraints_dgp_06/cmp/generic @@ -0,0 +1 @@ + diff --git a/tests/hp/hp_constraints_dgp_06/project_dgp_05/cmp/generic b/tests/hp/hp_constraints_dgp_06/project_dgp_05/cmp/generic new file mode 100644 index 0000000000..aeba16ad59 --- /dev/null +++ b/tests/hp/hp_constraints_dgp_06/project_dgp_05/cmp/generic @@ -0,0 +1,139 @@ + +DEAL::n_dofs=6 +DEAL:cg::Starting value 1.54 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_0, rel. error=0 +DEAL:cg::Starting value 3.16 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_1, rel. error=0.0557 +DEAL:cg::Starting value 4.85 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_2, rel. error=0.0990 +DEAL::n_dofs=6 +DEAL:cg::Starting value 1.69 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_0, rel. error=0 +DEAL:cg::Starting value 3.20 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_1, rel. error=0.0511 +DEAL:cg::Starting value 4.63 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_2, rel. error=0.0766 +DEAL::n_dofs=6 +DEAL:cg::Starting value 1.41 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_0, rel. error=0 +DEAL:cg::Starting value 2.77 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_1, rel. error=0.0447 +DEAL:cg::Starting value 4.22 +DEAL:cg::Convergence step 1 value 0 +DEAL::FE_DGP<2>(0), P_2, rel. error=0.0729 +DEAL::n_dofs=18 +DEAL:cg::Starting value 1.56 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_0, rel. error=0 +DEAL:cg::Starting value 3.18 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_1, rel. error=0.00818 +DEAL:cg::Starting value 4.95 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_2, rel. error=0.0138 +DEAL::n_dofs=18 +DEAL:cg::Starting value 1.72 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_0, rel. error=0 +DEAL:cg::Starting value 3.22 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_1, rel. error=0.00760 +DEAL:cg::Starting value 4.72 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_2, rel. error=0.0116 +DEAL::n_dofs=18 +DEAL:cg::Starting value 1.43 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_0, rel. error=0 +DEAL:cg::Starting value 2.80 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_1, rel. error=0.00423 +DEAL:cg::Starting value 4.30 +DEAL:cg::Convergence step 7 value 0 +DEAL::FE_DGP<2>(1), P_2, rel. error=0.00773 +DEAL::n_dofs=36 +DEAL:cg::Starting value 1.56 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_0, rel. error=0 +DEAL:cg::Starting value 3.19 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_1, rel. error=0 +DEAL:cg::Starting value 4.97 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_2, rel. error=0.00309 +DEAL:cg::Starting value 6.91 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_3, rel. error=0.00623 +DEAL::n_dofs=36 +DEAL:cg::Starting value 1.72 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_0, rel. error=0 +DEAL:cg::Starting value 3.22 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(2), P_1, rel. error=0 +DEAL:cg::Starting value 4.74 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(2), P_2, rel. error=0.00264 +DEAL:cg::Starting value 6.33 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_3, rel. error=0.00505 +DEAL::n_dofs=36 +DEAL:cg::Starting value 1.43 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_0, rel. error=0 +DEAL:cg::Starting value 2.80 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_1, rel. error=0 +DEAL:cg::Starting value 4.30 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_2, rel. error=0.00149 +DEAL:cg::Starting value 5.95 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(2), P_3, rel. error=0.00305 +DEAL::n_dofs=60 +DEAL:cg::Starting value 1.56 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(3), P_0, rel. error=0 +DEAL:cg::Starting value 3.19 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(3), P_1, rel. error=0 +DEAL:cg::Starting value 4.97 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(3), P_2, rel. error=0.000249 +DEAL:cg::Starting value 6.91 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(3), P_3, rel. error=0.000863 +DEAL::n_dofs=60 +DEAL:cg::Starting value 1.72 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(3), P_0, rel. error=0 +DEAL:cg::Starting value 3.22 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(3), P_1, rel. error=0 +DEAL:cg::Starting value 4.74 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(3), P_2, rel. error=0.000225 +DEAL:cg::Starting value 6.34 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(3), P_3, rel. error=0.000693 +DEAL::n_dofs=60 +DEAL:cg::Starting value 1.43 +DEAL:cg::Convergence step 8 value 0 +DEAL::FE_DGP<2>(3), P_0, rel. error=0 +DEAL:cg::Starting value 2.80 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(3), P_1, rel. error=0 +DEAL:cg::Starting value 4.30 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(3), P_2, rel. error=0.000144 +DEAL:cg::Starting value 5.95 +DEAL:cg::Convergence step 9 value 0 +DEAL::FE_DGP<2>(3), P_3, rel. error=0.000387 diff --git a/tests/hp/hp_constraints_dgp_monomial_06.cc b/tests/hp/hp_constraints_dgp_monomial_06.cc new file mode 100644 index 0000000000..b039c2c4b6 --- /dev/null +++ b/tests/hp/hp_constraints_dgp_monomial_06.cc @@ -0,0 +1,40 @@ +//---------------------------- hp_constraints_dgp_monomial_06.cc --------------------------- +// $Id: hp_constraints_dgp_monomial_06.cc 12732 2006-03-28 23:15:45Z wolf $ +// Version: $Name$ +// +// Copyright (C) 2006 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. +// +//---------------------------- hp_constraints_dgp_monomial_06.cc --------------------------- + + +// check that computation of hp constraints works for DGP_Monomial elements correctly + +// note that for mapped DGP(k) spaces, P(k) is not in the range of the +// mapping. However, P(k/2) is. Therefore, we have a gap for +// convergence, which we have to specify in the last argument to the +// call below + +char logname[] = "hp_constraints_dgp_monomial_06/output"; + + +#include "hp_constraints_common.h" + + +template +void test () +{ + hp::FECollection fe; + std::vector degrees; + for (unsigned int i=0; i<7-dim; ++i) + { + fe.push_back (FE_DGPMonomial(i)); + degrees.push_back (i); + } + + test_interpolation (fe, degrees); +} diff --git a/tests/hp/hp_constraints_dgp_monomial_06/cmp/generic b/tests/hp/hp_constraints_dgp_monomial_06/cmp/generic new file mode 100644 index 0000000000..8b13789179 --- /dev/null +++ b/tests/hp/hp_constraints_dgp_monomial_06/cmp/generic @@ -0,0 +1 @@ + diff --git a/tests/hp/hp_constraints_dgp_nonparametric_06.cc b/tests/hp/hp_constraints_dgp_nonparametric_06.cc new file mode 100644 index 0000000000..a7c1cc0c4a --- /dev/null +++ b/tests/hp/hp_constraints_dgp_nonparametric_06.cc @@ -0,0 +1,36 @@ +//---------------------------- hp_constraints_dgp_nonparametric_06.cc --------------------------- +// $Id: hp_constraints_dgp_nonparametric_06.cc 12732 2006-03-28 23:15:45Z wolf $ +// Version: $Name$ +// +// Copyright (C) 2006 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. +// +//---------------------------- hp_constraints_dgp_nonparametric_06.cc --------------------------- + + +// check that computation of hp constraints works for DGPNonparametric elements +// correctly on a uniformly refined mesh for functions of degree q + +char logname[] = "hp_constraints_dgp_nonparametric_06/output"; + + +#include "hp_constraints_common.h" + + +template +void test () +{ + hp::FECollection fe; + std::vector degrees; + for (unsigned int i=0; i<7-dim; ++i) + { + fe.push_back (FE_DGPNonparametric(i)); + degrees.push_back (i); + } + + test_interpolation (fe, degrees); +} diff --git a/tests/hp/hp_constraints_dgp_nonparametric_06/cmp/generic b/tests/hp/hp_constraints_dgp_nonparametric_06/cmp/generic new file mode 100644 index 0000000000..8b13789179 --- /dev/null +++ b/tests/hp/hp_constraints_dgp_nonparametric_06/cmp/generic @@ -0,0 +1 @@ + diff --git a/tests/hp/hp_constraints_dgq_06.cc b/tests/hp/hp_constraints_dgq_06.cc new file mode 100644 index 0000000000..ad4a8ba15a --- /dev/null +++ b/tests/hp/hp_constraints_dgq_06.cc @@ -0,0 +1,35 @@ +//---------------------------- hp_constraints_dgq_06.cc --------------------------- +// $Id: hp_constraints_dgq_06.cc 12732 2006-03-28 23:15:45Z wolf $ +// Version: $Name$ +// +// Copyright (C) 2006 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. +// +//---------------------------- hp_constraints_dgq_06.cc --------------------------- + + +// check that computation of hp constraints works for DGQ elements correctly + +char logname[] = "hp_constraints_dgq_06/output"; + + +#include "hp_constraints_common.h" + + +template +void test () +{ + hp::FECollection fe; + std::vector degrees; + for (unsigned int i=0; i<7-dim; ++i) + { + fe.push_back (FE_DGQ(i)); + degrees.push_back (i); + } + + test_interpolation (fe, degrees); +} diff --git a/tests/hp/hp_constraints_dgq_06/cmp/generic b/tests/hp/hp_constraints_dgq_06/cmp/generic new file mode 100644 index 0000000000..af25b9d4bb --- /dev/null +++ b/tests/hp/hp_constraints_dgq_06/cmp/generic @@ -0,0 +1,999 @@ + +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(0) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(1) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(2) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(3) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(4) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<1>(5) vs. FE_DGQ<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(0) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(1) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(2) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(3) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<2>(4) vs. FE_DGQ<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(0) vs. FE_DGQ<3>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(0) vs. FE_DGQ<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(0) vs. FE_DGQ<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(0) vs. FE_DGQ<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(1) vs. FE_DGQ<3>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(1) vs. FE_DGQ<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(1) vs. FE_DGQ<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(1) vs. FE_DGQ<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(2) vs. FE_DGQ<3>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(2) vs. FE_DGQ<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(2) vs. FE_DGQ<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(2) vs. FE_DGQ<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(3) vs. FE_DGQ<3>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(3) vs. FE_DGQ<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(3) vs. FE_DGQ<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(3) vs. FE_DGQ<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(0) vs. FE_DGQ<3>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(0) vs. FE_DGQ<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(0) vs. FE_DGQ<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(0) vs. FE_DGQ<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(1) vs. FE_DGQ<3>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(1) vs. FE_DGQ<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(1) vs. FE_DGQ<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(1) vs. FE_DGQ<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(2) vs. FE_DGQ<3>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(2) vs. FE_DGQ<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(2) vs. FE_DGQ<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(2) vs. FE_DGQ<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(3) vs. FE_DGQ<3>(0) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(3) vs. FE_DGQ<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(3) vs. FE_DGQ<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_DGQ<3>(3) vs. FE_DGQ<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 diff --git a/tests/hp/hp_constraints_q_06.cc b/tests/hp/hp_constraints_q_06.cc new file mode 100644 index 0000000000..3df2aa273f --- /dev/null +++ b/tests/hp/hp_constraints_q_06.cc @@ -0,0 +1,35 @@ +//---------------------------- hp_constraints_q_06.cc --------------------------- +// $Id: hp_constraints_q_06.cc 12732 2006-03-28 23:15:45Z wolf $ +// Version: $Name$ +// +// Copyright (C) 2006 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. +// +//---------------------------- hp_constraints_q_06.cc --------------------------- + + +// check that computation of hp constraints works for Q elements correctly + +char logname[] = "hp_constraints_q_06/output"; + + +#include "hp_constraints_common.h" + + +template +void test () +{ + hp::FECollection fe; + std::vector degrees; + for (unsigned int i=1; i<7-dim; ++i) + { + fe.push_back (FE_Q(i)); + degrees.push_back (i); + } + + test_interpolation (fe, degrees); +} diff --git a/tests/hp/hp_constraints_q_06/cmp/generic b/tests/hp/hp_constraints_q_06/cmp/generic new file mode 100644 index 0000000000..26d44d2f31 --- /dev/null +++ b/tests/hp/hp_constraints_q_06/cmp/generic @@ -0,0 +1,637 @@ + +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(1) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(2) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(3) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(4) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<1>(5) vs. FE_Q<1>(5) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(1) vs. FE_Q<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(1) vs. FE_Q<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(1) vs. FE_Q<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(1) vs. FE_Q<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(2) vs. FE_Q<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(2) vs. FE_Q<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(2) vs. FE_Q<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(2) vs. FE_Q<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(3) vs. FE_Q<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(3) vs. FE_Q<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(3) vs. FE_Q<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(3) vs. FE_Q<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(4) vs. FE_Q<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(4) vs. FE_Q<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(4) vs. FE_Q<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(4) vs. FE_Q<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(1) vs. FE_Q<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(1) vs. FE_Q<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(1) vs. FE_Q<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(1) vs. FE_Q<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(2) vs. FE_Q<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(2) vs. FE_Q<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(2) vs. FE_Q<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(2) vs. FE_Q<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(3) vs. FE_Q<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(3) vs. FE_Q<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(3) vs. FE_Q<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(3) vs. FE_Q<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(4) vs. FE_Q<2>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(4) vs. FE_Q<2>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(4) vs. FE_Q<2>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<2>(4) vs. FE_Q<2>(4) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(1) vs. FE_Q<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(1) vs. FE_Q<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(1) vs. FE_Q<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(2) vs. FE_Q<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(2) vs. FE_Q<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(2) vs. FE_Q<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(3) vs. FE_Q<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(3) vs. FE_Q<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(3) vs. FE_Q<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(1) vs. FE_Q<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(1) vs. FE_Q<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(1) vs. FE_Q<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(2) vs. FE_Q<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(2) vs. FE_Q<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(2) vs. FE_Q<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(3) vs. FE_Q<3>(1) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(3) vs. FE_Q<3>(2) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL::Testing FE_Q<3>(3) vs. FE_Q<3>(3) +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 +DEAL:: Relative interpolation error before constraints: 0 +DEAL:: Relative difference after constraints: 0 diff --git a/tests/hp/hp_constraints_q_system_06.cc b/tests/hp/hp_constraints_q_system_06.cc new file mode 100644 index 0000000000..a891b9692a --- /dev/null +++ b/tests/hp/hp_constraints_q_system_06.cc @@ -0,0 +1,42 @@ +//---------------------------- hp_constraints_q_system_06.cc --------------------------- +// $Id: hp_constraints_q_system_06.cc 12732 2006-03-28 23:15:45Z wolf $ +// Version: $Name$ +// +// Copyright (C) 2006 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. +// +//---------------------------- hp_constraints_q_system_06.cc --------------------------- + + +// check that computation of hp constraints works for FESystem(FE_Q) elements correctly +// on a uniformly refined mesh for functions of degree q + +char logname[] = "hp_constraints_q_system_06/output"; + + +#include "hp_constraints_common.h" + + +template +void test () +{ + hp::FECollection fe; + std::vector degrees; + for (unsigned int i=1; i<7-dim; ++i) + { + // in contrast to all the other + // hp_constraints_q_system_* tests, we + // use two continuous elements here, + // since we can't interpolate DGQ + // elements + fe.push_back (FESystem(FE_Q(i), 1, + FE_Q(i+1), 1)); + degrees.push_back (i); + } + + test_interpolation (fe, degrees); +} diff --git a/tests/hp/hp_constraints_q_system_06/cmp/generic b/tests/hp/hp_constraints_q_system_06/cmp/generic new file mode 100644 index 0000000000..81cd139899 --- /dev/null +++ b/tests/hp/hp_constraints_q_system_06/cmp/generic @@ -0,0 +1,108 @@ + +DEAL::n_dofs=140 + 27 0: 0.500 + 27 46: 0.500 + 48 0: 0.500 + 48 46: 0.500 + 61 47: 0.500 + 61 49: 0.500 + 82 0: 0.667 + 82 46: 0.333 + 83 0: 0.833 + 83 46: 0.167 + 84 6: -0.111 + 84 49: 0.222 + 84 120: 0.889 + 85 6: 0.222 + 85 49: -0.111 + 85 120: 0.889 + 86 0: 0.333 + 86 46: 0.333 + 86 49: 0.333 + 87 0: 0.167 + 87 46: 0.167 + 87 49: 0.667 + 88 0: 0.556 + 88 1: -0.111 + 88 6: 0.556 + 89 0: 0.222 + 89 1: -0.111 + 89 6: 0.889 + 119 6: 1.00 + 122 0: -0.125 + 122 1: 0.375 + 122 6: 0.750 +DEAL::n_dofs=129 + 2 23: 0.500 + 2 24: 0.500 + 5 1: 0.500 + 5 24: 0.500 + 36 1: 0.500 + 36 24: 0.500 + 37 24: 0.500 + 37 26: 0.500 + 49 1: 0.250 + 49 24: 0.250 + 49 38: 0.500 + 51 1: 0.750 + 51 24: 0.250 + 70 24: 0.333 + 70 26: 0.667 + 71 24: 0.167 + 71 26: 0.833 + 72 38: 0.222 + 72 107: -0.111 + 72 109: 0.889 + 73 38: -0.111 + 73 107: 0.222 + 73 109: 0.889 + 74 24: 0.333 + 74 26: 0.333 + 74 38: 0.333 + 75 24: 0.167 + 75 26: 0.167 + 75 38: 0.667 +DEAL::n_dofs=146 + 3 0: -0.333 + 3 2: 1.00 + 3 39: 0.333 + 8 39: 0.222 + 8 40: -0.111 + 8 44: 0.889 + 9 39: -0.111 + 9 40: 0.222 + 9 44: 0.889 + 42 39: 0.500 + 42 136: 0.500 + 65 0: -0.0556 + 65 2: 0.250 + 65 39: 0.0278 + 65 101: 0.889 + 65 123: -0.111 + 66 0: 0.0278 + 66 2: -0.125 + 66 39: -0.0139 + 66 101: 0.889 + 66 123: 0.222 + 67 0: 0.417 + 67 2: 0.625 + 67 39: -0.0417 + 68 0: -2.78e-17 + 68 2: 1.00 + 69 122: 0.667 + 69 123: 0.333 + 70 122: 0.333 + 70 123: 0.667 + 100 0: -0.250 + 100 2: 1.12 + 100 39: 0.125 + 102 39: 0.750 + 102 136: 0.250 + 103 0: -0.312 + 103 2: 0.844 + 103 39: 0.469 + 104 39: 0.250 + 104 123: 0.500 + 104 136: 0.250 + 135 39: 0.500 + 135 136: 0.500