From 6a470e4c72653524b79d12bc5a640f9a87df1e85 Mon Sep 17 00:00:00 2001 From: Luca Heltai Date: Mon, 25 Aug 2014 11:32:54 +0200 Subject: [PATCH] Made MappingQ compatible with Manifold. --- doc/news/changes.h | 14 +- include/deal.II/fe/mapping_q.h | 91 +- source/fe/mapping_q.cc | 220 +-- tests/manifold/spherical_manifold_05.cc | 91 + tests/manifold/spherical_manifold_05.output | 1733 +++++++++++++++++++ 5 files changed, 2029 insertions(+), 120 deletions(-) create mode 100644 tests/manifold/spherical_manifold_05.cc create mode 100644 tests/manifold/spherical_manifold_05.output diff --git a/doc/news/changes.h b/doc/news/changes.h index 2c11a85ba4..bb77d0f02a 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -111,7 +111,14 @@ inconvenience this causes.
    - + +
  1. New: Made MappingQ aware of + Manifold. Now we can use high order mappings that + actually follow the geometry also on the interior of codimension + zero meshes. +
    (Luca Heltai, 2014/09/13) +
  2. +
  3. New: Added two optional parameters to TriaAccessor::center() and a new method TriaAccessor::intermediate_point(). They allow to query for a @@ -122,18 +129,19 @@ inconvenience this causes. TriaAccessor::center() interface when querying for new points.
    (Luca Heltai, 2014/09/13) - +
  4. New: The new tutorial program step-52 explains how to use the new time stepping methods.
    (Bruno Turcksin, Damien Lebrun-Grandie, 2014/09/12) - +
  5. New: The new tutorial program step-53 explains how to deal with complicated geometries.
    (Wolfgang Bangerth, Luca Heltai, 2014/09/02) +
  6. Changed: Namespace std_cxx1x has been renamed to namespace std_cxx11 to match the fact that the corresponding C++ standard diff --git a/include/deal.II/fe/mapping_q.h b/include/deal.II/fe/mapping_q.h index 28e4aefcbf..02016110db 100644 --- a/include/deal.II/fe/mapping_q.h +++ b/include/deal.II/fe/mapping_q.h @@ -22,6 +22,7 @@ #include #include #include +#include DEAL_II_NAMESPACE_OPEN @@ -265,7 +266,35 @@ protected: add_quad_support_points(const typename Triangulation::cell_iterator &cell, std::vector > &a) const; + private: + /** + * Ask the manifold descriptor to return intermediate points on + * lines or faces. The function needs to return one or multiple + * points (depending on the number of elements in the output vector + * @p points that lie inside a line, quad or hex). Whether it is a + * line, quad or hex doesn't really matter to this function but it + * can be inferred from the number of input points in the @p + * surrounding_points vector. + */ + void get_intermediate_points(const Manifold &manifold, + const std::vector > &surrounding_points, + std::vector > &points) const; + + + /** + * Ask the manifold descriptor to return intermediate points on the + * object pointed to by the TriaIterator @p iter. This function + * tries to be backward compatible with respect to the differences + * between Boundary and Manifold, + * querying the first whenever the passed @p manifold can be + * upgraded to a Boundary. + */ + template + void get_intermediate_points_on_object(const Manifold &manifold, + const TriaIterator &iter, + std::vector > &points) const; + virtual typename Mapping::InternalDataBase * @@ -434,6 +463,18 @@ private: */ const FE_Q feq; + + /* + * The default line support points. These are used when computing + * the location in real space of the support points on lines and + * quads, which are asked to the Manifold class. + * + * The number of quadrature points depends on the degree of this + * class, and it matches the number of degrees of freedom of an + * FE_Q<1>(this->degree). + */ + QGaussLobatto<1> line_support_points; + /** * Declare other MappingQ classes friends. */ @@ -461,20 +502,52 @@ void MappingQ<3>::set_laplace_on_hex_vector(Table<2,double> &lohvs) const; template <> void MappingQ<1>::compute_laplace_vector(Table<2,double> &) const; -template <> -void MappingQ<1>::add_line_support_points (const Triangulation<1>::cell_iterator &, - std::vector > &) const; -template <> -void MappingQ<1,2>::add_line_support_points (const Triangulation<1,2>::cell_iterator &, - std::vector > &) const; -template <> -void MappingQ<1,3>::add_line_support_points (const Triangulation<1,3>::cell_iterator &, - std::vector > &) const; + template<> void MappingQ<3>::add_quad_support_points(const Triangulation<3>::cell_iterator &cell, std::vector > &a) const; +// ---- Templated functions ---- // +template +template +void +MappingQ::get_intermediate_points_on_object(const Manifold &manifold, + const TriaIterator &iter, + std::vector > &points) const +{ + const unsigned int structdim = TriaIterator::AccessorType::structure_dimension; + // Try backward compatibility option. + const Boundary *boundary = dynamic_cast *>(&manifold); + if (boundary) // This is actually a boundary. Call old methods. + switch (structdim) + { + case 1: + { + const typename Triangulation::line_iterator line = iter; + boundary->get_intermediate_points_on_line(line, points); + return; + } + case 2: + { + const typename Triangulation::quad_iterator quad = iter; + boundary->get_intermediate_points_on_quad(quad, points); + return; + } + default: + Assert(false, ExcInternalError()); + return; + } + else + { + std::vector > sp(GeometryInfo::vertices_per_cell); + for (unsigned int i=0; ivertex(i); + get_intermediate_points(manifold, sp, points); + } +} + + #endif // DOXYGEN DEAL_II_NAMESPACE_CLOSE diff --git a/source/fe/mapping_q.cc b/source/fe/mapping_q.cc index afc17259d3..835d8405f0 100644 --- a/source/fe/mapping_q.cc +++ b/source/fe/mapping_q.cc @@ -71,7 +71,8 @@ MappingQ<1>::MappingQ (const unsigned int, n_shape_functions(2), renumber(0), use_mapping_q_on_all_cells (false), - feq(degree) + feq(degree), + line_support_points(degree+1) {} @@ -85,7 +86,8 @@ MappingQ<1>::MappingQ (const MappingQ<1> &m): n_shape_functions(2), renumber(0), use_mapping_q_on_all_cells (m.use_mapping_q_on_all_cells), - feq(degree) + feq(degree), + line_support_points(degree+1) {} template<> @@ -128,13 +130,13 @@ MappingQ::MappingQ (const unsigned int p, degree))), use_mapping_q_on_all_cells (use_mapping_q_on_all_cells || (dim != spacedim)), - feq(degree) + feq(degree), + line_support_points(degree+1) { // Construct the tensor product polynomials used as shape functions for the // Qp mapping of cells at the boundary. - const QGaussLobatto<1> points(degree+1); tensor_pols = new TensorProductPolynomials - (Polynomials::generate_complete_Lagrange_basis(points.get_points())); + (Polynomials::generate_complete_Lagrange_basis(line_support_points.get_points())); Assert (n_shape_functions==tensor_pols->n(), ExcInternalError()); Assert(n_inner+n_outer==n_shape_functions, ExcInternalError()); @@ -161,7 +163,8 @@ MappingQ::MappingQ (const MappingQ &mapping) n_shape_functions(mapping.n_shape_functions), renumber(mapping.renumber), use_mapping_q_on_all_cells (mapping.use_mapping_q_on_all_cells), - feq(degree) + feq(degree), + line_support_points(degree+1) { tensor_pols=new TensorProductPolynomials (*mapping.tensor_pols); laplace_on_quad_vector=mapping.laplace_on_quad_vector; @@ -744,101 +747,26 @@ MappingQ::compute_support_points_laplace(const typename Triangulat } - -template <> -void -MappingQ<1>::add_line_support_points (const Triangulation<1>::cell_iterator &, - std::vector > &) const -{ - // there are no points on bounding lines which are to be added - const unsigned int dim=1; - Assert (dim > 1, ExcImpossibleInDim(dim)); -} - - - -template <> -void -MappingQ<1,2>::add_line_support_points (const Triangulation<1,2>::cell_iterator &cell, - std::vector > &a) const -{ - const unsigned int dim = 1; - const unsigned int spacedim = 2; - // Ask for the mid point, if that's the only thing we need. - if (degree==2) - { - const Boundary *const boundary - = &(cell->get_triangulation().get_boundary(cell->material_id())); - a.push_back(boundary->get_new_point_on_line(cell)); - } - else - // otherwise call the more complicated functions and ask for inner points - // from the boundary description - { - std::vector > line_points (degree-1); - - const Boundary *const boundary - = &(cell->get_triangulation().get_boundary(cell->material_id())); - - boundary->get_intermediate_points_on_line (cell, line_points); - // Append all points - a.insert (a.end(), line_points.begin(), line_points.end()); - } -} - - - -template <> -void -MappingQ<1,3>::add_line_support_points (const Triangulation<1,3>::cell_iterator &cell, - std::vector > &a) const -{ - const unsigned int dim = 1; - const unsigned int spacedim = 3; - // Ask for the mid point, if that's the only thing we need. - if (degree==2) - { - const Boundary *const boundary - = &(cell->get_triangulation().get_boundary(cell->material_id())); - a.push_back(boundary->get_new_point_on_line(cell)); - } - else - // otherwise call the more complicated functions and ask for inner points - // from the boundary description - { - std::vector > line_points (degree-1); - - const Boundary *const boundary - = &(cell->get_triangulation().get_boundary(cell->material_id())); - - boundary->get_intermediate_points_on_line (cell, line_points); - // Append all points - a.insert (a.end(), line_points.begin(), line_points.end()); - } -} - - - template void MappingQ::add_line_support_points (const typename Triangulation::cell_iterator &cell, std::vector > &a) const { - static const StraightBoundary straight_boundary; // if we only need the midpoint, then ask for it. if (degree==2) { for (unsigned int line_no=0; line_no::lines_per_cell; ++line_no) { - const typename Triangulation::line_iterator line = cell->line(line_no); - const Boundary *const boundary - = (line->at_boundary()? - &line->get_triangulation().get_boundary(line->boundary_indicator()): - (dim != spacedim) ? - &line->get_triangulation().get_boundary(cell->material_id()): - &straight_boundary); - - a.push_back(boundary->get_new_point_on_line(line)); + const typename Triangulation::line_iterator line = + (dim == 1 ? + static_cast::line_iterator>(cell) : + cell->line(line_no)); + + const Manifold &manifold = + ( ( line->manifold_id() == numbers::invalid_manifold_id ) && + ( dim < spacedim ) ? cell->get_manifold() : + line->get_manifold() ); + a.push_back(manifold.get_new_point_on_line(line)); }; } else @@ -846,21 +774,24 @@ MappingQ::add_line_support_points (const typename Triangulation > line_points (degree-1); - // loop over each of the lines, and if it is at the boundary, then first // get the boundary description and second compute the points on it for (unsigned int line_no=0; line_no::lines_per_cell; ++line_no) { - const typename Triangulation::line_iterator line = cell->line(line_no); + const typename Triangulation::line_iterator + line = (dim == 1 + ? + static_cast::line_iterator>(cell) + : + cell->line(line_no)); - const Boundary *const boundary - = (line->at_boundary()? - &line->get_triangulation().get_boundary(line->boundary_indicator()) : - (dim != spacedim) ? - &line->get_triangulation().get_boundary(cell->material_id()) : - &straight_boundary); + const Manifold &manifold = + ( ( line->manifold_id() == numbers::invalid_manifold_id ) && + ( dim < spacedim ) ? cell->get_manifold() : + line->get_manifold() ); + + get_intermediate_points_on_object (manifold, line, line_points); - boundary->get_intermediate_points_on_line (line, line_points); if (dim==3) { // in 3D, lines might be in wrong orientation. if so, reverse @@ -898,6 +829,9 @@ add_quad_support_points(const Triangulation<3>::cell_iterator &cell, // used if only one line of face quad is at boundary std::vector > b(4*degree); + // Used by the new Manifold interface. This vector collects the + // vertices used to compute the intermediate points. + std::vector > vertices(4); // loop over all faces and collect points on them for (unsigned int face_no=0; face_no::cell_iterator &cell, // points on it if (face->at_boundary()) { - face->get_triangulation().get_boundary(face->boundary_indicator()) - .get_intermediate_points_on_quad (face, quad_points); + get_intermediate_points_on_object(face->get_manifold(), face, quad_points); + // in 3D, the orientation, flip and rotation of the face might not // match what we expect here, namely the standard orientation. thus // reorder points accordingly. since a Mapping uses the same shape @@ -992,9 +926,12 @@ add_quad_support_points(const Triangulation<3>::cell_iterator &cell, } else { - // face is entirely in the interior. get intermediate points - // from a straight boundary object - straight_boundary.get_intermediate_points_on_quad (face, quad_points); + // face is entirely in the interior. get intermediate + // points from the relevant manifold object. + vertices.resize(4); + for (unsigned int i=0; i<4; ++i) + vertices[i] = face->vertex(i); + get_intermediate_points (face->get_manifold(), vertices, quad_points); // in 3D, the orientation, flip and rotation of the face might // not match what we expect here, namely the standard // orientation. thus reorder points accordingly. since a Mapping @@ -1019,9 +956,7 @@ add_quad_support_points(const Triangulation<2,3>::cell_iterator &cell, std::vector > &a) const { std::vector > quad_points ((degree-1)*(degree-1)); - - cell->get_triangulation().get_boundary(cell->material_id()) - .get_intermediate_points_on_quad (cell, quad_points); + get_intermediate_points_on_object (cell->get_manifold(), cell, quad_points); for (unsigned int i=0; i::clone () const } +template +void +MappingQ::get_intermediate_points (const Manifold &manifold, + const std::vector > &surrounding_points, + std::vector > &points) const +{ + Assert(surrounding_points.size() >= 2, ExcMessage("At least 2 surrounding points are required")); + const unsigned int n=points.size(); + Assert(n>0, ExcMessage("You can't ask for 0 intermediate points.")); + std::vector w(surrounding_points.size()); + + switch (surrounding_points.size()) + { + case 2: + { + // If two points are passed, these are the two vertices, and + // we can only compute degree-1 intermediate points. + AssertDimension(n, degree-1); + for (unsigned int i=0; i quadrature(surrounding_points, w); + points[i] = manifold.get_new_point(quadrature); + } + break; + } + + case 4: + { + Assert(spacedim >= 2, ExcImpossibleInDim(spacedim)); + const unsigned m= + static_cast(std::sqrt(static_cast(n))); + // is n a square number + Assert(m*m==n, ExcInternalError()); + + // If four points are passed, these are the two vertices, and + // we can only compute (degree-1)*(degree-1) intermediate + // points. + AssertDimension(m, degree-1); + + for (unsigned int i=0; i quadrature(surrounding_points, w); + points[i*m+j]=manifold.get_new_point(quadrature); + } + } + break; + } + + case 8: + Assert(false, ExcNotImplemented()); + break; + default: + Assert(false, ExcInternalError()); + break; + } +} + // explicit instantiations diff --git a/tests/manifold/spherical_manifold_05.cc b/tests/manifold/spherical_manifold_05.cc new file mode 100644 index 0000000000..ee8708c008 --- /dev/null +++ b/tests/manifold/spherical_manifold_05.cc @@ -0,0 +1,91 @@ +//---------------------------- spherical_manifold_01.cc --------------------------- +// Copyright (C) 2011, 2013 by the mathLab team. +// +// This file is subject to LGPL 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. +// +//---------------------------- spherical_manifold_04.cc --------------------------- + + +// Test that the flat manifold does what it should on a sphere surface. + +#include "../tests.h" + +#include +#include + + +// all include files you need here +#include + +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include +#include +#include + +// Helper function +template +void test(unsigned int degree) +{ + deallog << "Testing dim=" << dim <<", degree=" + << degree << std::endl; + + SphericalManifold manifold; + Triangulation tria; + GridGenerator::hyper_shell(tria, Point(), .4, .6, 6); + typename Triangulation::active_cell_iterator cell; + + for(cell = tria.begin_active(); cell != tria.end(); ++cell) + cell->set_all_manifold_ids(1); + + tria.set_manifold(1, manifold); + + MappingQ mapping(degree, true); + FE_Q fe(degree); + DoFHandler dh(tria); + dh.distribute_dofs(fe); + QGaussLobatto quad(degree+1); + + FEValues fe_v(mapping, fe, quad, update_quadrature_points); + + // char fname[50]; + // sprintf(fname, "out_%d_%d.gpl", dim, degree); + // std::ofstream ofile(fname); + std::ostream &ofile = deallog.get_file_stream(); + + for(typename DoFHandler::active_cell_iterator cell = dh.begin_active(); + cell != dh.end(); ++cell) { + fe_v.reinit(cell); + for(unsigned int q=0; q(d); + test<3>(d); + } + return 0; +} + diff --git a/tests/manifold/spherical_manifold_05.output b/tests/manifold/spherical_manifold_05.output new file mode 100644 index 0000000000..cb262e4144 --- /dev/null +++ b/tests/manifold/spherical_manifold_05.output @@ -0,0 +1,1733 @@ + +DEAL::Testing dim=2, degree=1 +0.600000 0.00000 +0.300000 0.519615 +0.400000 0.00000 +0.200000 0.346410 + +0.300000 0.519615 +-0.300000 0.519615 +0.200000 0.346410 +-0.200000 0.346410 + +-0.300000 0.519615 +-0.600000 7.34788e-17 +-0.200000 0.346410 +-0.400000 4.89859e-17 + +-0.600000 7.34788e-17 +-0.300000 -0.519615 +-0.400000 4.89859e-17 +-0.200000 -0.346410 + +-0.300000 -0.519615 +0.300000 -0.519615 +-0.200000 -0.346410 +0.200000 -0.346410 + +0.300000 -0.519615 +0.600000 0.00000 +0.200000 -0.346410 +0.400000 0.00000 + + +DEAL::Testing dim=3, degree=1 +-0.346410 -0.346410 -0.346410 +0.346410 -0.346410 -0.346410 +-0.346410 0.346410 -0.346410 +0.346410 0.346410 -0.346410 +-0.230940 -0.230940 -0.230940 +0.230940 -0.230940 -0.230940 +-0.230940 0.230940 -0.230940 +0.230940 0.230940 -0.230940 + +0.346410 -0.346410 -0.346410 +0.346410 0.346410 -0.346410 +0.230940 -0.230940 -0.230940 +0.230940 0.230940 -0.230940 +0.346410 -0.346410 0.346410 +0.346410 0.346410 0.346410 +0.230940 -0.230940 0.230940 +0.230940 0.230940 0.230940 + +-0.346410 -0.346410 0.346410 +0.346410 -0.346410 0.346410 +-0.230940 -0.230940 0.230940 +0.230940 -0.230940 0.230940 +-0.346410 0.346410 0.346410 +0.346410 0.346410 0.346410 +-0.230940 0.230940 0.230940 +0.230940 0.230940 0.230940 + +-0.346410 -0.346410 -0.346410 +-0.230940 -0.230940 -0.230940 +-0.346410 0.346410 -0.346410 +-0.230940 0.230940 -0.230940 +-0.346410 -0.346410 0.346410 +-0.230940 -0.230940 0.230940 +-0.346410 0.346410 0.346410 +-0.230940 0.230940 0.230940 + +-0.346410 -0.346410 -0.346410 +0.346410 -0.346410 -0.346410 +-0.230940 -0.230940 -0.230940 +0.230940 -0.230940 -0.230940 +-0.346410 -0.346410 0.346410 +0.346410 -0.346410 0.346410 +-0.230940 -0.230940 0.230940 +0.230940 -0.230940 0.230940 + +-0.346410 0.346410 -0.346410 +-0.230940 0.230940 -0.230940 +0.346410 0.346410 -0.346410 +0.230940 0.230940 -0.230940 +-0.346410 0.346410 0.346410 +-0.230940 0.230940 0.230940 +0.346410 0.346410 0.346410 +0.230940 0.230940 0.230940 + + +DEAL::Testing dim=2, degree=2 +0.600000 0.00000 +0.519615 0.300000 +0.300000 0.519615 +0.500000 0.00000 +0.396755 0.229066 +0.250000 0.433013 +0.400000 0.00000 +0.346410 0.200000 +0.200000 0.346410 + +0.300000 0.519615 +3.67394e-17 0.600000 +-0.300000 0.519615 +0.250000 0.433013 +6.00533e-17 0.458133 +-0.250000 0.433013 +0.200000 0.346410 +2.44929e-17 0.400000 +-0.200000 0.346410 + +-0.300000 0.519615 +-0.519615 0.300000 +-0.600000 7.34788e-17 +-0.250000 0.433013 +-0.396755 0.229066 +-0.500000 6.12323e-17 +-0.200000 0.346410 +-0.346410 0.200000 +-0.400000 4.89859e-17 + +-0.600000 7.34788e-17 +-0.519615 -0.300000 +-0.300000 -0.519615 +-0.500000 6.12323e-17 +-0.396755 -0.229066 +-0.250000 -0.433013 +-0.400000 4.89859e-17 +-0.346410 -0.200000 +-0.200000 -0.346410 + +-0.300000 -0.519615 +-1.10218e-16 -0.600000 +0.300000 -0.519615 +-0.250000 -0.433013 +-1.59343e-16 -0.458133 +0.250000 -0.433013 +-0.200000 -0.346410 +-7.34788e-17 -0.400000 +0.200000 -0.346410 + +0.300000 -0.519615 +0.519615 -0.300000 +0.600000 0.00000 +0.250000 -0.433013 +0.396755 -0.229066 +0.500000 0.00000 +0.200000 -0.346410 +0.346410 -0.200000 +0.400000 0.00000 + + +DEAL::Testing dim=3, degree=2 +-0.346410 -0.346410 -0.346410 +0.00000 -0.424264 -0.424264 +0.346410 -0.346410 -0.346410 +-0.424264 0.00000 -0.424264 +0.00000 0.00000 -0.600000 +0.424264 0.00000 -0.424264 +-0.346410 0.346410 -0.346410 +0.00000 0.424264 -0.424264 +0.346410 0.346410 -0.346410 +-0.288675 -0.288675 -0.288675 +0.00000 -0.313004 -0.313004 +0.288675 -0.288675 -0.288675 +-0.313004 0.00000 -0.313004 +0.00000 0.00000 -0.350929 +0.313004 0.00000 -0.313004 +-0.288675 0.288675 -0.288675 +0.00000 0.313004 -0.313004 +0.288675 0.288675 -0.288675 +-0.230940 -0.230940 -0.230940 +0.00000 -0.282843 -0.282843 +0.230940 -0.230940 -0.230940 +-0.282843 0.00000 -0.282843 +0.00000 0.00000 -0.400000 +0.282843 0.00000 -0.282843 +-0.230940 0.230940 -0.230940 +0.00000 0.282843 -0.282843 +0.230940 0.230940 -0.230940 + +0.346410 -0.346410 -0.346410 +0.424264 0.00000 -0.424264 +0.346410 0.346410 -0.346410 +0.288675 -0.288675 -0.288675 +0.313004 0.00000 -0.313004 +0.288675 0.288675 -0.288675 +0.230940 -0.230940 -0.230940 +0.282843 0.00000 -0.282843 +0.230940 0.230940 -0.230940 +0.424264 -0.424264 0.00000 +0.600000 0.00000 0.00000 +0.424264 0.424264 0.00000 +0.313004 -0.313004 0.00000 +0.350929 0.00000 -6.93889e-18 +0.313004 0.313004 0.00000 +0.282843 -0.282843 0.00000 +0.400000 0.00000 0.00000 +0.282843 0.282843 0.00000 +0.346410 -0.346410 0.346410 +0.424264 0.00000 0.424264 +0.346410 0.346410 0.346410 +0.288675 -0.288675 0.288675 +0.313004 0.00000 0.313004 +0.288675 0.288675 0.288675 +0.230940 -0.230940 0.230940 +0.282843 0.00000 0.282843 +0.230940 0.230940 0.230940 + +-0.346410 -0.346410 0.346410 +0.00000 -0.424264 0.424264 +0.346410 -0.346410 0.346410 +-0.288675 -0.288675 0.288675 +0.00000 -0.313004 0.313004 +0.288675 -0.288675 0.288675 +-0.230940 -0.230940 0.230940 +0.00000 -0.282843 0.282843 +0.230940 -0.230940 0.230940 +-0.424264 0.00000 0.424264 +0.00000 0.00000 0.600000 +0.424264 0.00000 0.424264 +-0.313004 0.00000 0.313004 +0.00000 -6.93889e-18 0.350929 +0.313004 0.00000 0.313004 +-0.282843 0.00000 0.282843 +0.00000 0.00000 0.400000 +0.282843 0.00000 0.282843 +-0.346410 0.346410 0.346410 +0.00000 0.424264 0.424264 +0.346410 0.346410 0.346410 +-0.288675 0.288675 0.288675 +0.00000 0.313004 0.313004 +0.288675 0.288675 0.288675 +-0.230940 0.230940 0.230940 +0.00000 0.282843 0.282843 +0.230940 0.230940 0.230940 + +-0.346410 -0.346410 -0.346410 +-0.288675 -0.288675 -0.288675 +-0.230940 -0.230940 -0.230940 +-0.424264 0.00000 -0.424264 +-0.313004 0.00000 -0.313004 +-0.282843 0.00000 -0.282843 +-0.346410 0.346410 -0.346410 +-0.288675 0.288675 -0.288675 +-0.230940 0.230940 -0.230940 +-0.424264 -0.424264 0.00000 +-0.313004 -0.313004 0.00000 +-0.282843 -0.282843 0.00000 +-0.600000 0.00000 0.00000 +-0.350929 0.00000 3.46945e-18 +-0.400000 0.00000 0.00000 +-0.424264 0.424264 0.00000 +-0.313004 0.313004 0.00000 +-0.282843 0.282843 0.00000 +-0.346410 -0.346410 0.346410 +-0.288675 -0.288675 0.288675 +-0.230940 -0.230940 0.230940 +-0.424264 0.00000 0.424264 +-0.313004 0.00000 0.313004 +-0.282843 0.00000 0.282843 +-0.346410 0.346410 0.346410 +-0.288675 0.288675 0.288675 +-0.230940 0.230940 0.230940 + +-0.346410 -0.346410 -0.346410 +0.00000 -0.424264 -0.424264 +0.346410 -0.346410 -0.346410 +-0.288675 -0.288675 -0.288675 +0.00000 -0.313004 -0.313004 +0.288675 -0.288675 -0.288675 +-0.230940 -0.230940 -0.230940 +0.00000 -0.282843 -0.282843 +0.230940 -0.230940 -0.230940 +-0.424264 -0.424264 0.00000 +0.00000 -0.600000 0.00000 +0.424264 -0.424264 0.00000 +-0.313004 -0.313004 0.00000 +0.00000 -0.350929 -6.93889e-18 +0.313004 -0.313004 0.00000 +-0.282843 -0.282843 0.00000 +0.00000 -0.400000 0.00000 +0.282843 -0.282843 0.00000 +-0.346410 -0.346410 0.346410 +0.00000 -0.424264 0.424264 +0.346410 -0.346410 0.346410 +-0.288675 -0.288675 0.288675 +0.00000 -0.313004 0.313004 +0.288675 -0.288675 0.288675 +-0.230940 -0.230940 0.230940 +0.00000 -0.282843 0.282843 +0.230940 -0.230940 0.230940 + +-0.346410 0.346410 -0.346410 +-0.288675 0.288675 -0.288675 +-0.230940 0.230940 -0.230940 +0.00000 0.424264 -0.424264 +0.00000 0.313004 -0.313004 +0.00000 0.282843 -0.282843 +0.346410 0.346410 -0.346410 +0.288675 0.288675 -0.288675 +0.230940 0.230940 -0.230940 +-0.424264 0.424264 0.00000 +-0.313004 0.313004 0.00000 +-0.282843 0.282843 0.00000 +0.00000 0.600000 0.00000 +0.00000 0.350929 3.46945e-18 +0.00000 0.400000 0.00000 +0.424264 0.424264 0.00000 +0.313004 0.313004 0.00000 +0.282843 0.282843 0.00000 +-0.346410 0.346410 0.346410 +-0.288675 0.288675 0.288675 +-0.230940 0.230940 0.230940 +0.00000 0.424264 0.424264 +0.00000 0.313004 0.313004 +0.00000 0.282843 0.282843 +0.346410 0.346410 0.346410 +0.288675 0.288675 0.288675 +0.230940 0.230940 0.230940 + + +DEAL::Testing dim=2, degree=3 +0.600000 0.00000 +0.575043 0.171248 +0.435827 0.412377 +0.300000 0.519615 +0.544721 0.00000 +0.496021 0.144666 +0.373295 0.357234 +0.272361 0.471743 +0.455279 0.00000 +0.412787 0.119966 +0.310287 0.297501 +0.227639 0.394283 +0.400000 0.00000 +0.383362 0.114166 +0.290551 0.274918 +0.200000 0.346410 + +0.300000 0.519615 +0.139216 0.583626 +-0.139216 0.583626 +-0.300000 0.519615 +0.272361 0.471743 +0.122726 0.501900 +-0.122726 0.501900 +-0.272361 0.471743 +0.227639 0.394283 +0.102500 0.417467 +-0.102500 0.417467 +-0.227639 0.394283 +0.200000 0.346410 +0.0928106 0.389084 +-0.0928106 0.389084 +-0.200000 0.346410 + +-0.300000 0.519615 +-0.435827 0.412377 +-0.575043 0.171248 +-0.600000 7.34788e-17 +-0.272361 0.471743 +-0.373295 0.357234 +-0.496021 0.144666 +-0.544721 6.67091e-17 +-0.227639 0.394283 +-0.310287 0.297501 +-0.412787 0.119966 +-0.455279 5.57556e-17 +-0.200000 0.346410 +-0.290551 0.274918 +-0.383362 0.114166 +-0.400000 4.89859e-17 + +-0.600000 7.34788e-17 +-0.575043 -0.171248 +-0.435827 -0.412377 +-0.300000 -0.519615 +-0.544721 6.67091e-17 +-0.496021 -0.144666 +-0.373295 -0.357234 +-0.272361 -0.471743 +-0.455279 5.57556e-17 +-0.412787 -0.119966 +-0.310287 -0.297501 +-0.227639 -0.394283 +-0.400000 4.89859e-17 +-0.383362 -0.114166 +-0.290551 -0.274918 +-0.200000 -0.346410 + +-0.300000 -0.519615 +-0.139216 -0.583626 +0.139216 -0.583626 +0.300000 -0.519615 +-0.272361 -0.471743 +-0.122726 -0.501900 +0.122726 -0.501900 +0.272361 -0.471743 +-0.227639 -0.394283 +-0.102500 -0.417467 +0.102500 -0.417467 +0.227639 -0.394283 +-0.200000 -0.346410 +-0.0928106 -0.389084 +0.0928106 -0.389084 +0.200000 -0.346410 + +0.300000 -0.519615 +0.435827 -0.412377 +0.575043 -0.171248 +0.600000 0.00000 +0.272361 -0.471743 +0.373295 -0.357234 +0.496021 -0.144666 +0.544721 0.00000 +0.227639 -0.394283 +0.310287 -0.297501 +0.412787 -0.119966 +0.455279 0.00000 +0.200000 -0.346410 +0.290551 -0.274918 +0.383362 -0.114166 +0.400000 0.00000 + + +DEAL::Testing dim=3, degree=3 +-0.346410 -0.346410 -0.346410 +-0.180907 -0.404520 -0.404520 +0.180907 -0.404520 -0.404520 +0.346410 -0.346410 -0.346410 +-0.404520 -0.180907 -0.404520 +-0.226779 -0.226779 -0.507093 +0.226779 -0.226779 -0.507093 +0.404520 -0.180907 -0.404520 +-0.404520 0.180907 -0.404520 +-0.226779 0.226779 -0.507093 +0.226779 0.226779 -0.507093 +0.404520 0.180907 -0.404520 +-0.346410 0.346410 -0.346410 +-0.180907 0.404520 -0.404520 +0.180907 0.404520 -0.404520 +0.346410 0.346410 -0.346410 +-0.314495 -0.314495 -0.314495 +-0.145392 -0.341873 -0.341873 +0.145392 -0.341873 -0.341873 +0.314495 -0.314495 -0.314495 +-0.341873 -0.145392 -0.341873 +-0.160643 -0.160643 -0.383418 +0.160643 -0.160643 -0.383418 +0.341873 -0.145392 -0.341873 +-0.341873 0.145392 -0.341873 +-0.160643 0.160643 -0.383418 +0.160643 0.160643 -0.383418 +0.341873 0.145392 -0.341873 +-0.314495 0.314495 -0.314495 +-0.145392 0.341873 -0.341873 +0.145392 0.341873 -0.341873 +0.314495 0.314495 -0.314495 +-0.262855 -0.262855 -0.262855 +-0.121136 -0.283903 -0.283903 +0.121136 -0.283903 -0.283903 +0.262855 -0.262855 -0.262855 +-0.283903 -0.121136 -0.283903 +-0.132887 -0.132887 -0.315483 +0.132887 -0.132887 -0.315483 +0.283903 -0.121136 -0.283903 +-0.283903 0.121136 -0.283903 +-0.132887 0.132887 -0.315483 +0.132887 0.132887 -0.315483 +0.283903 0.121136 -0.283903 +-0.262855 0.262855 -0.262855 +-0.121136 0.283903 -0.283903 +0.121136 0.283903 -0.283903 +0.262855 0.262855 -0.262855 +-0.230940 -0.230940 -0.230940 +-0.120605 -0.269680 -0.269680 +0.120605 -0.269680 -0.269680 +0.230940 -0.230940 -0.230940 +-0.269680 -0.120605 -0.269680 +-0.151186 -0.151186 -0.338062 +0.151186 -0.151186 -0.338062 +0.269680 -0.120605 -0.269680 +-0.269680 0.120605 -0.269680 +-0.151186 0.151186 -0.338062 +0.151186 0.151186 -0.338062 +0.269680 0.120605 -0.269680 +-0.230940 0.230940 -0.230940 +-0.120605 0.269680 -0.269680 +0.120605 0.269680 -0.269680 +0.230940 0.230940 -0.230940 + +0.346410 -0.346410 -0.346410 +0.404520 -0.180907 -0.404520 +0.404520 0.180907 -0.404520 +0.346410 0.346410 -0.346410 +0.314495 -0.314495 -0.314495 +0.341873 -0.145392 -0.341873 +0.341873 0.145392 -0.341873 +0.314495 0.314495 -0.314495 +0.262855 -0.262855 -0.262855 +0.283903 -0.121136 -0.283903 +0.283903 0.121136 -0.283903 +0.262855 0.262855 -0.262855 +0.230940 -0.230940 -0.230940 +0.269680 -0.120605 -0.269680 +0.269680 0.120605 -0.269680 +0.230940 0.230940 -0.230940 +0.404520 -0.404520 -0.180907 +0.507093 -0.226779 -0.226779 +0.507093 0.226779 -0.226779 +0.404520 0.404520 -0.180907 +0.341873 -0.341873 -0.145392 +0.383418 -0.160643 -0.160643 +0.383418 0.160643 -0.160643 +0.341873 0.341873 -0.145392 +0.283903 -0.283903 -0.121136 +0.315483 -0.132887 -0.132887 +0.315483 0.132887 -0.132887 +0.283903 0.283903 -0.121136 +0.269680 -0.269680 -0.120605 +0.338062 -0.151186 -0.151186 +0.338062 0.151186 -0.151186 +0.269680 0.269680 -0.120605 +0.404520 -0.404520 0.180907 +0.507093 -0.226779 0.226779 +0.507093 0.226779 0.226779 +0.404520 0.404520 0.180907 +0.341873 -0.341873 0.145392 +0.383418 -0.160643 0.160643 +0.383418 0.160643 0.160643 +0.341873 0.341873 0.145392 +0.283903 -0.283903 0.121136 +0.315483 -0.132887 0.132887 +0.315483 0.132887 0.132887 +0.283903 0.283903 0.121136 +0.269680 -0.269680 0.120605 +0.338062 -0.151186 0.151186 +0.338062 0.151186 0.151186 +0.269680 0.269680 0.120605 +0.346410 -0.346410 0.346410 +0.404520 -0.180907 0.404520 +0.404520 0.180907 0.404520 +0.346410 0.346410 0.346410 +0.314495 -0.314495 0.314495 +0.341873 -0.145392 0.341873 +0.341873 0.145392 0.341873 +0.314495 0.314495 0.314495 +0.262855 -0.262855 0.262855 +0.283903 -0.121136 0.283903 +0.283903 0.121136 0.283903 +0.262855 0.262855 0.262855 +0.230940 -0.230940 0.230940 +0.269680 -0.120605 0.269680 +0.269680 0.120605 0.269680 +0.230940 0.230940 0.230940 + +-0.346410 -0.346410 0.346410 +-0.180907 -0.404520 0.404520 +0.180907 -0.404520 0.404520 +0.346410 -0.346410 0.346410 +-0.314495 -0.314495 0.314495 +-0.145392 -0.341873 0.341873 +0.145392 -0.341873 0.341873 +0.314495 -0.314495 0.314495 +-0.262855 -0.262855 0.262855 +-0.121136 -0.283903 0.283903 +0.121136 -0.283903 0.283903 +0.262855 -0.262855 0.262855 +-0.230940 -0.230940 0.230940 +-0.120605 -0.269680 0.269680 +0.120605 -0.269680 0.269680 +0.230940 -0.230940 0.230940 +-0.404520 -0.180907 0.404520 +-0.226779 -0.226779 0.507093 +0.226779 -0.226779 0.507093 +0.404520 -0.180907 0.404520 +-0.341873 -0.145392 0.341873 +-0.160643 -0.160643 0.383418 +0.160643 -0.160643 0.383418 +0.341873 -0.145392 0.341873 +-0.283903 -0.121136 0.283903 +-0.132887 -0.132887 0.315483 +0.132887 -0.132887 0.315483 +0.283903 -0.121136 0.283903 +-0.269680 -0.120605 0.269680 +-0.151186 -0.151186 0.338062 +0.151186 -0.151186 0.338062 +0.269680 -0.120605 0.269680 +-0.404520 0.180907 0.404520 +-0.226779 0.226779 0.507093 +0.226779 0.226779 0.507093 +0.404520 0.180907 0.404520 +-0.341873 0.145392 0.341873 +-0.160643 0.160643 0.383418 +0.160643 0.160643 0.383418 +0.341873 0.145392 0.341873 +-0.283903 0.121136 0.283903 +-0.132887 0.132887 0.315483 +0.132887 0.132887 0.315483 +0.283903 0.121136 0.283903 +-0.269680 0.120605 0.269680 +-0.151186 0.151186 0.338062 +0.151186 0.151186 0.338062 +0.269680 0.120605 0.269680 +-0.346410 0.346410 0.346410 +-0.180907 0.404520 0.404520 +0.180907 0.404520 0.404520 +0.346410 0.346410 0.346410 +-0.314495 0.314495 0.314495 +-0.145392 0.341873 0.341873 +0.145392 0.341873 0.341873 +0.314495 0.314495 0.314495 +-0.262855 0.262855 0.262855 +-0.121136 0.283903 0.283903 +0.121136 0.283903 0.283903 +0.262855 0.262855 0.262855 +-0.230940 0.230940 0.230940 +-0.120605 0.269680 0.269680 +0.120605 0.269680 0.269680 +0.230940 0.230940 0.230940 + +-0.346410 -0.346410 -0.346410 +-0.314495 -0.314495 -0.314495 +-0.262855 -0.262855 -0.262855 +-0.230940 -0.230940 -0.230940 +-0.404520 -0.180907 -0.404520 +-0.341873 -0.145392 -0.341873 +-0.283903 -0.121136 -0.283903 +-0.269680 -0.120605 -0.269680 +-0.404520 0.180907 -0.404520 +-0.341873 0.145392 -0.341873 +-0.283903 0.121136 -0.283903 +-0.269680 0.120605 -0.269680 +-0.346410 0.346410 -0.346410 +-0.314495 0.314495 -0.314495 +-0.262855 0.262855 -0.262855 +-0.230940 0.230940 -0.230940 +-0.404520 -0.404520 -0.180907 +-0.341873 -0.341873 -0.145392 +-0.283903 -0.283903 -0.121136 +-0.269680 -0.269680 -0.120605 +-0.507093 -0.226779 -0.226779 +-0.383418 -0.160643 -0.160643 +-0.315483 -0.132887 -0.132887 +-0.338062 -0.151186 -0.151186 +-0.507093 0.226779 -0.226779 +-0.383418 0.160643 -0.160643 +-0.315483 0.132887 -0.132887 +-0.338062 0.151186 -0.151186 +-0.404520 0.404520 -0.180907 +-0.341873 0.341873 -0.145392 +-0.283903 0.283903 -0.121136 +-0.269680 0.269680 -0.120605 +-0.404520 -0.404520 0.180907 +-0.341873 -0.341873 0.145392 +-0.283903 -0.283903 0.121136 +-0.269680 -0.269680 0.120605 +-0.507093 -0.226779 0.226779 +-0.383418 -0.160643 0.160643 +-0.315483 -0.132887 0.132887 +-0.338062 -0.151186 0.151186 +-0.507093 0.226779 0.226779 +-0.383418 0.160643 0.160643 +-0.315483 0.132887 0.132887 +-0.338062 0.151186 0.151186 +-0.404520 0.404520 0.180907 +-0.341873 0.341873 0.145392 +-0.283903 0.283903 0.121136 +-0.269680 0.269680 0.120605 +-0.346410 -0.346410 0.346410 +-0.314495 -0.314495 0.314495 +-0.262855 -0.262855 0.262855 +-0.230940 -0.230940 0.230940 +-0.404520 -0.180907 0.404520 +-0.341873 -0.145392 0.341873 +-0.283903 -0.121136 0.283903 +-0.269680 -0.120605 0.269680 +-0.404520 0.180907 0.404520 +-0.341873 0.145392 0.341873 +-0.283903 0.121136 0.283903 +-0.269680 0.120605 0.269680 +-0.346410 0.346410 0.346410 +-0.314495 0.314495 0.314495 +-0.262855 0.262855 0.262855 +-0.230940 0.230940 0.230940 + +-0.346410 -0.346410 -0.346410 +-0.180907 -0.404520 -0.404520 +0.180907 -0.404520 -0.404520 +0.346410 -0.346410 -0.346410 +-0.314495 -0.314495 -0.314495 +-0.145392 -0.341873 -0.341873 +0.145392 -0.341873 -0.341873 +0.314495 -0.314495 -0.314495 +-0.262855 -0.262855 -0.262855 +-0.121136 -0.283903 -0.283903 +0.121136 -0.283903 -0.283903 +0.262855 -0.262855 -0.262855 +-0.230940 -0.230940 -0.230940 +-0.120605 -0.269680 -0.269680 +0.120605 -0.269680 -0.269680 +0.230940 -0.230940 -0.230940 +-0.404520 -0.404520 -0.180907 +-0.226779 -0.507093 -0.226779 +0.226779 -0.507093 -0.226779 +0.404520 -0.404520 -0.180907 +-0.341873 -0.341873 -0.145392 +-0.160643 -0.383418 -0.160643 +0.160643 -0.383418 -0.160643 +0.341873 -0.341873 -0.145392 +-0.283903 -0.283903 -0.121136 +-0.132887 -0.315483 -0.132887 +0.132887 -0.315483 -0.132887 +0.283903 -0.283903 -0.121136 +-0.269680 -0.269680 -0.120605 +-0.151186 -0.338062 -0.151186 +0.151186 -0.338062 -0.151186 +0.269680 -0.269680 -0.120605 +-0.404520 -0.404520 0.180907 +-0.226779 -0.507093 0.226779 +0.226779 -0.507093 0.226779 +0.404520 -0.404520 0.180907 +-0.341873 -0.341873 0.145392 +-0.160643 -0.383418 0.160643 +0.160643 -0.383418 0.160643 +0.341873 -0.341873 0.145392 +-0.283903 -0.283903 0.121136 +-0.132887 -0.315483 0.132887 +0.132887 -0.315483 0.132887 +0.283903 -0.283903 0.121136 +-0.269680 -0.269680 0.120605 +-0.151186 -0.338062 0.151186 +0.151186 -0.338062 0.151186 +0.269680 -0.269680 0.120605 +-0.346410 -0.346410 0.346410 +-0.180907 -0.404520 0.404520 +0.180907 -0.404520 0.404520 +0.346410 -0.346410 0.346410 +-0.314495 -0.314495 0.314495 +-0.145392 -0.341873 0.341873 +0.145392 -0.341873 0.341873 +0.314495 -0.314495 0.314495 +-0.262855 -0.262855 0.262855 +-0.121136 -0.283903 0.283903 +0.121136 -0.283903 0.283903 +0.262855 -0.262855 0.262855 +-0.230940 -0.230940 0.230940 +-0.120605 -0.269680 0.269680 +0.120605 -0.269680 0.269680 +0.230940 -0.230940 0.230940 + +-0.346410 0.346410 -0.346410 +-0.314495 0.314495 -0.314495 +-0.262855 0.262855 -0.262855 +-0.230940 0.230940 -0.230940 +-0.180907 0.404520 -0.404520 +-0.145392 0.341873 -0.341873 +-0.121136 0.283903 -0.283903 +-0.120605 0.269680 -0.269680 +0.180907 0.404520 -0.404520 +0.145392 0.341873 -0.341873 +0.121136 0.283903 -0.283903 +0.120605 0.269680 -0.269680 +0.346410 0.346410 -0.346410 +0.314495 0.314495 -0.314495 +0.262855 0.262855 -0.262855 +0.230940 0.230940 -0.230940 +-0.404520 0.404520 -0.180907 +-0.341873 0.341873 -0.145392 +-0.283903 0.283903 -0.121136 +-0.269680 0.269680 -0.120605 +-0.226779 0.507093 -0.226779 +-0.160643 0.383418 -0.160643 +-0.132887 0.315483 -0.132887 +-0.151186 0.338062 -0.151186 +0.226779 0.507093 -0.226779 +0.160643 0.383418 -0.160643 +0.132887 0.315483 -0.132887 +0.151186 0.338062 -0.151186 +0.404520 0.404520 -0.180907 +0.341873 0.341873 -0.145392 +0.283903 0.283903 -0.121136 +0.269680 0.269680 -0.120605 +-0.404520 0.404520 0.180907 +-0.341873 0.341873 0.145392 +-0.283903 0.283903 0.121136 +-0.269680 0.269680 0.120605 +-0.226779 0.507093 0.226779 +-0.160643 0.383418 0.160643 +-0.132887 0.315483 0.132887 +-0.151186 0.338062 0.151186 +0.226779 0.507093 0.226779 +0.160643 0.383418 0.160643 +0.132887 0.315483 0.132887 +0.151186 0.338062 0.151186 +0.404520 0.404520 0.180907 +0.341873 0.341873 0.145392 +0.283903 0.283903 0.121136 +0.269680 0.269680 0.120605 +-0.346410 0.346410 0.346410 +-0.314495 0.314495 0.314495 +-0.262855 0.262855 0.262855 +-0.230940 0.230940 0.230940 +-0.180907 0.404520 0.404520 +-0.145392 0.341873 0.341873 +-0.121136 0.283903 0.283903 +-0.120605 0.269680 0.269680 +0.180907 0.404520 0.404520 +0.145392 0.341873 0.341873 +0.121136 0.283903 0.283903 +0.120605 0.269680 0.269680 +0.346410 0.346410 0.346410 +0.314495 0.314495 0.314495 +0.262855 0.262855 0.262855 +0.230940 0.230940 0.230940 + + +DEAL::Testing dim=2, degree=4 +0.600000 0.00000 +0.590218 0.107903 +0.519615 0.300000 +0.388556 0.457192 +0.300000 0.519615 +0.565465 0.00000 +0.540540 0.0963727 +0.467564 0.269948 +0.353731 0.419935 +0.282733 0.489707 +0.500000 0.00000 +0.469403 0.0815937 +0.398726 0.230205 +0.305364 0.365718 +0.250000 0.433013 +0.434535 0.00000 +0.413935 0.0734274 +0.356846 0.206025 +0.270557 0.321764 +0.217267 0.376318 +0.400000 0.00000 +0.393478 0.0719357 +0.346410 0.200000 +0.259037 0.304794 +0.200000 0.346410 + +0.300000 0.519615 +0.201662 0.565095 +3.67394e-17 0.600000 +-0.201662 0.565095 +-0.300000 0.519615 +0.282733 0.489707 +0.186809 0.516308 +1.90820e-17 0.539897 +-0.186809 0.516308 +-0.282733 0.489707 +0.250000 0.433013 +0.164039 0.447312 +2.60209e-18 0.460409 +-0.164039 0.447312 +-0.250000 0.433013 +0.217267 0.376318 +0.143377 0.395192 +-3.46945e-18 0.412050 +-0.143377 0.395192 +-0.217267 0.376318 +0.200000 0.346410 +0.134441 0.376730 +2.44929e-17 0.400000 +-0.134441 0.376730 +-0.200000 0.346410 + +-0.300000 0.519615 +-0.388556 0.457192 +-0.519615 0.300000 +-0.590218 0.107903 +-0.600000 7.34788e-17 +-0.282733 0.489707 +-0.353731 0.419935 +-0.467564 0.269948 +-0.540540 0.0963727 +-0.565465 6.92495e-17 +-0.250000 0.433013 +-0.305364 0.365718 +-0.398726 0.230205 +-0.469403 0.0815937 +-0.500000 6.12323e-17 +-0.217267 0.376318 +-0.270557 0.321764 +-0.356846 0.206025 +-0.413935 0.0734274 +-0.434535 5.32151e-17 +-0.200000 0.346410 +-0.259037 0.304794 +-0.346410 0.200000 +-0.393478 0.0719357 +-0.400000 4.89859e-17 + +-0.600000 7.34788e-17 +-0.590218 -0.107903 +-0.519615 -0.300000 +-0.388556 -0.457192 +-0.300000 -0.519615 +-0.565465 6.92495e-17 +-0.540540 -0.0963727 +-0.467564 -0.269948 +-0.353731 -0.419935 +-0.282733 -0.489707 +-0.500000 6.12323e-17 +-0.469403 -0.0815937 +-0.398726 -0.230205 +-0.305364 -0.365718 +-0.250000 -0.433013 +-0.434535 5.32151e-17 +-0.413935 -0.0734274 +-0.356846 -0.206025 +-0.270557 -0.321764 +-0.217267 -0.376318 +-0.400000 4.89859e-17 +-0.393478 -0.0719357 +-0.346410 -0.200000 +-0.259037 -0.304794 +-0.200000 -0.346410 + +-0.300000 -0.519615 +-0.201662 -0.565095 +-1.10218e-16 -0.600000 +0.201662 -0.565095 +0.300000 -0.519615 +-0.282733 -0.489707 +-0.186809 -0.516308 +-1.67834e-16 -0.539897 +0.186809 -0.516308 +0.282733 -0.489707 +-0.250000 -0.433013 +-0.164039 -0.447312 +-1.52656e-16 -0.460409 +0.164039 -0.447312 +0.250000 -0.433013 +-0.217267 -0.376318 +-0.143377 -0.395192 +-1.49186e-16 -0.412050 +0.143377 -0.395192 +0.217267 -0.376318 +-0.200000 -0.346410 +-0.134441 -0.376730 +-7.34788e-17 -0.400000 +0.134441 -0.376730 +0.200000 -0.346410 + +0.300000 -0.519615 +0.388556 -0.457192 +0.519615 -0.300000 +0.590218 -0.107903 +0.600000 0.00000 +0.282733 -0.489707 +0.353731 -0.419935 +0.467564 -0.269948 +0.540540 -0.0963727 +0.565465 0.00000 +0.250000 -0.433013 +0.305364 -0.365718 +0.398726 -0.230205 +0.469403 -0.0815937 +0.500000 0.00000 +0.217267 -0.376318 +0.270557 -0.321764 +0.356846 -0.206025 +0.413935 -0.0734274 +0.434535 0.00000 +0.200000 -0.346410 +0.259037 -0.304794 +0.346410 -0.200000 +0.393478 -0.0719357 +0.400000 0.00000 + + +DEAL::Testing dim=3, degree=4 +-0.346410 -0.346410 -0.346410 +-0.252050 -0.385013 -0.385013 +0.00000 -0.424264 -0.424264 +0.252050 -0.385013 -0.385013 +0.346410 -0.346410 -0.346410 +-0.385013 -0.252050 -0.385013 +-0.288231 -0.288231 -0.440280 +0.00000 -0.328634 -0.501996 +0.288231 -0.288231 -0.440280 +0.385013 -0.252050 -0.385013 +-0.424264 0.00000 -0.424264 +-0.328634 -5.02771e-18 -0.501996 +0.00000 0.00000 -0.600000 +0.328634 -4.02217e-17 -0.501996 +0.424264 0.00000 -0.424264 +-0.385013 0.252050 -0.385013 +-0.288231 0.288231 -0.440280 +0.00000 0.328634 -0.501996 +0.288231 0.288231 -0.440280 +0.385013 0.252050 -0.385013 +-0.346410 0.346410 -0.346410 +-0.252050 0.385013 -0.385013 +0.00000 0.424264 -0.424264 +0.252050 0.385013 -0.385013 +0.346410 0.346410 -0.346410 +-0.326472 -0.326472 -0.326472 +-0.221967 -0.350620 -0.350620 +3.85976e-17 -0.373675 -0.373675 +0.221967 -0.350620 -0.350620 +0.326472 -0.326472 -0.326472 +-0.350620 -0.221967 -0.350620 +-0.241179 -0.241179 -0.384643 +4.72001e-17 -0.259938 -0.418217 +0.241179 -0.241179 -0.384643 +0.350620 -0.221967 -0.350620 +-0.373675 3.55618e-17 -0.373675 +-0.259938 5.46133e-17 -0.418217 +5.21501e-17 4.79759e-17 -0.463353 +0.259938 2.62377e-17 -0.418217 +0.373675 3.55618e-17 -0.373675 +-0.350620 0.221967 -0.350620 +-0.241179 0.241179 -0.384643 +4.18502e-17 0.259938 -0.418217 +0.241179 0.241179 -0.384643 +0.350620 0.221967 -0.350620 +-0.326472 0.326472 -0.326472 +-0.221967 0.350620 -0.350620 +3.85976e-17 0.373675 -0.373675 +0.221967 0.350620 -0.350620 +0.326472 0.326472 -0.326472 +-0.288675 -0.288675 -0.288675 +-0.190787 -0.301862 -0.301862 +6.07153e-17 -0.314268 -0.314268 +0.190787 -0.301862 -0.301862 +0.288675 -0.288675 -0.288675 +-0.301862 -0.190787 -0.301862 +-0.200042 -0.200042 -0.318983 +6.07695e-17 -0.208903 -0.335247 +0.200042 -0.200042 -0.318983 +0.301862 -0.190787 -0.301862 +-0.314268 6.24500e-17 -0.314268 +-0.208903 6.78168e-17 -0.335247 +9.12898e-17 8.13152e-17 -0.355665 +0.208903 7.18826e-17 -0.335247 +0.314268 6.24500e-17 -0.314268 +-0.301862 0.190787 -0.301862 +-0.200042 0.200042 -0.318983 +7.10152e-17 0.208903 -0.335247 +0.200042 0.200042 -0.318983 +0.301862 0.190787 -0.301862 +-0.288675 0.288675 -0.288675 +-0.190787 0.301862 -0.301862 +6.07153e-17 0.314268 -0.314268 +0.190787 0.301862 -0.301862 +0.288675 0.288675 -0.288675 +-0.250879 -0.250879 -0.250879 +-0.169722 -0.268073 -0.268073 +4.16334e-17 -0.284434 -0.284434 +0.169722 -0.268073 -0.268073 +0.250879 -0.250879 -0.250879 +-0.268073 -0.169722 -0.268073 +-0.183237 -0.183237 -0.292142 +4.41270e-17 -0.196324 -0.315742 +0.183237 -0.183237 -0.292142 +0.268073 -0.169722 -0.268073 +-0.284434 4.16334e-17 -0.284434 +-0.196324 4.51028e-17 -0.315742 +4.51028e-17 5.16080e-17 -0.347060 +0.196324 5.89806e-17 -0.315742 +0.284434 4.16334e-17 -0.284434 +-0.268073 0.169722 -0.268073 +-0.183237 0.183237 -0.292142 +4.51028e-17 0.196324 -0.315742 +0.183237 0.183237 -0.292142 +0.268073 0.169722 -0.268073 +-0.250879 0.250879 -0.250879 +-0.169722 0.268073 -0.268073 +4.16334e-17 0.284434 -0.284434 +0.169722 0.268073 -0.268073 +0.250879 0.250879 -0.250879 +-0.230940 -0.230940 -0.230940 +-0.168034 -0.256676 -0.256676 +0.00000 -0.282843 -0.282843 +0.168034 -0.256676 -0.256676 +0.230940 -0.230940 -0.230940 +-0.256676 -0.168034 -0.256676 +-0.192154 -0.192154 -0.293520 +0.00000 -0.219089 -0.334664 +0.192154 -0.192154 -0.293520 +0.256676 -0.168034 -0.256676 +-0.282843 0.00000 -0.282843 +-0.219089 0.00000 -0.334664 +0.00000 0.00000 -0.400000 +0.219089 2.01108e-17 -0.334664 +0.282843 0.00000 -0.282843 +-0.256676 0.168034 -0.256676 +-0.192154 0.192154 -0.293520 +0.00000 0.219089 -0.334664 +0.192154 0.192154 -0.293520 +0.256676 0.168034 -0.256676 +-0.230940 0.230940 -0.230940 +-0.168034 0.256676 -0.256676 +0.00000 0.282843 -0.282843 +0.168034 0.256676 -0.256676 +0.230940 0.230940 -0.230940 + +0.346410 -0.346410 -0.346410 +0.385013 -0.252050 -0.385013 +0.424264 0.00000 -0.424264 +0.385013 0.252050 -0.385013 +0.346410 0.346410 -0.346410 +0.326472 -0.326472 -0.326472 +0.350620 -0.221967 -0.350620 +0.373675 3.55618e-17 -0.373675 +0.350620 0.221967 -0.350620 +0.326472 0.326472 -0.326472 +0.288675 -0.288675 -0.288675 +0.301862 -0.190787 -0.301862 +0.314268 6.24500e-17 -0.314268 +0.301862 0.190787 -0.301862 +0.288675 0.288675 -0.288675 +0.250879 -0.250879 -0.250879 +0.268073 -0.169722 -0.268073 +0.284434 4.16334e-17 -0.284434 +0.268073 0.169722 -0.268073 +0.250879 0.250879 -0.250879 +0.230940 -0.230940 -0.230940 +0.256676 -0.168034 -0.256676 +0.282843 0.00000 -0.282843 +0.256676 0.168034 -0.256676 +0.230940 0.230940 -0.230940 +0.385013 -0.385013 -0.252050 +0.440280 -0.288231 -0.288231 +0.501996 -5.02771e-18 -0.328634 +0.440280 0.288231 -0.288231 +0.385013 0.385013 -0.252050 +0.350620 -0.350620 -0.221967 +0.384643 -0.241179 -0.241179 +0.418217 5.35223e-17 -0.259938 +0.384643 0.241179 -0.241179 +0.350620 0.350620 -0.221967 +0.301862 -0.301862 -0.190787 +0.318983 -0.200042 -0.200042 +0.335247 6.08780e-17 -0.208903 +0.318983 0.200042 -0.200042 +0.301862 0.301862 -0.190787 +0.268073 -0.268073 -0.169722 +0.292142 -0.183237 -0.183237 +0.315742 4.38018e-17 -0.196324 +0.292142 0.183237 -0.183237 +0.268073 0.268073 -0.169722 +0.256676 -0.256676 -0.168034 +0.293520 -0.192154 -0.192154 +0.334664 0.00000 -0.219089 +0.293520 0.192154 -0.192154 +0.256676 0.256676 -0.168034 +0.424264 -0.424264 0.00000 +0.501996 -0.328634 0.00000 +0.600000 0.00000 0.00000 +0.501996 0.328634 0.00000 +0.424264 0.424264 0.00000 +0.373675 -0.373675 3.85976e-17 +0.418217 -0.259938 5.88451e-17 +0.463353 5.25296e-17 6.22874e-17 +0.418217 0.259938 4.66207e-17 +0.373675 0.373675 3.85976e-17 +0.314268 -0.314268 6.07153e-17 +0.335247 -0.208903 6.94431e-17 +0.355665 7.26415e-17 7.02563e-17 +0.335247 0.208903 7.19910e-17 +0.314268 0.314268 6.07153e-17 +0.284434 -0.284434 4.16334e-17 +0.315742 -0.196324 4.15249e-17 +0.347060 5.23670e-17 4.72712e-17 +0.315742 0.196324 4.16334e-17 +0.284434 0.284434 4.16334e-17 +0.282843 -0.282843 0.00000 +0.334664 -0.219089 0.00000 +0.400000 0.00000 0.00000 +0.334664 0.219089 0.00000 +0.282843 0.282843 0.00000 +0.385013 -0.385013 0.252050 +0.440280 -0.288231 0.288231 +0.501996 -4.02217e-17 0.328634 +0.440280 0.288231 0.288231 +0.385013 0.385013 0.252050 +0.350620 -0.350620 0.221967 +0.384643 -0.241179 0.241179 +0.418217 2.68882e-17 0.259938 +0.384643 0.241179 0.241179 +0.350620 0.350620 0.221967 +0.301862 -0.301862 0.190787 +0.318983 -0.200042 0.200042 +0.335247 7.11237e-17 0.208903 +0.318983 0.200042 0.200042 +0.301862 0.301862 0.190787 +0.268073 -0.268073 0.169722 +0.292142 -0.183237 0.183237 +0.315742 5.72459e-17 0.196324 +0.292142 0.183237 0.183237 +0.268073 0.268073 0.169722 +0.256676 -0.256676 0.168034 +0.293520 -0.192154 0.192154 +0.334664 2.01108e-17 0.219089 +0.293520 0.192154 0.192154 +0.256676 0.256676 0.168034 +0.346410 -0.346410 0.346410 +0.385013 -0.252050 0.385013 +0.424264 0.00000 0.424264 +0.385013 0.252050 0.385013 +0.346410 0.346410 0.346410 +0.326472 -0.326472 0.326472 +0.350620 -0.221967 0.350620 +0.373675 3.55618e-17 0.373675 +0.350620 0.221967 0.350620 +0.326472 0.326472 0.326472 +0.288675 -0.288675 0.288675 +0.301862 -0.190787 0.301862 +0.314268 6.24500e-17 0.314268 +0.301862 0.190787 0.301862 +0.288675 0.288675 0.288675 +0.250879 -0.250879 0.250879 +0.268073 -0.169722 0.268073 +0.284434 4.16334e-17 0.284434 +0.268073 0.169722 0.268073 +0.250879 0.250879 0.250879 +0.230940 -0.230940 0.230940 +0.256676 -0.168034 0.256676 +0.282843 0.00000 0.282843 +0.256676 0.168034 0.256676 +0.230940 0.230940 0.230940 + +-0.346410 -0.346410 0.346410 +-0.252050 -0.385013 0.385013 +0.00000 -0.424264 0.424264 +0.252050 -0.385013 0.385013 +0.346410 -0.346410 0.346410 +-0.326472 -0.326472 0.326472 +-0.221967 -0.350620 0.350620 +3.55618e-17 -0.373675 0.373675 +0.221967 -0.350620 0.350620 +0.326472 -0.326472 0.326472 +-0.288675 -0.288675 0.288675 +-0.190787 -0.301862 0.301862 +6.24500e-17 -0.314268 0.314268 +0.190787 -0.301862 0.301862 +0.288675 -0.288675 0.288675 +-0.250879 -0.250879 0.250879 +-0.169722 -0.268073 0.268073 +4.16334e-17 -0.284434 0.284434 +0.169722 -0.268073 0.268073 +0.250879 -0.250879 0.250879 +-0.230940 -0.230940 0.230940 +-0.168034 -0.256676 0.256676 +0.00000 -0.282843 0.282843 +0.168034 -0.256676 0.256676 +0.230940 -0.230940 0.230940 +-0.385013 -0.252050 0.385013 +-0.288231 -0.288231 0.440280 +-5.02771e-18 -0.328634 0.501996 +0.288231 -0.288231 0.440280 +0.385013 -0.252050 0.385013 +-0.350620 -0.221967 0.350620 +-0.241179 -0.241179 0.384643 +5.52570e-17 -0.259938 0.418217 +0.241179 -0.241179 0.384643 +0.350620 -0.221967 0.350620 +-0.301862 -0.190787 0.301862 +-0.200042 -0.200042 0.318983 +6.26127e-17 -0.208903 0.335247 +0.200042 -0.200042 0.318983 +0.301862 -0.190787 0.301862 +-0.268073 -0.169722 0.268073 +-0.183237 -0.183237 0.292142 +4.55365e-17 -0.196324 0.315742 +0.183237 -0.183237 0.292142 +0.268073 -0.169722 0.268073 +-0.256676 -0.168034 0.256676 +-0.192154 -0.192154 0.293520 +0.00000 -0.219089 0.334664 +0.192154 -0.192154 0.293520 +0.256676 -0.168034 0.256676 +-0.424264 0.00000 0.424264 +-0.328634 0.00000 0.501996 +0.00000 0.00000 0.600000 +0.328634 0.00000 0.501996 +0.424264 0.00000 0.424264 +-0.373675 3.85976e-17 0.373675 +-0.259938 5.88451e-17 0.418217 +5.25296e-17 6.22874e-17 0.463353 +0.259938 4.66207e-17 0.418217 +0.373675 3.85976e-17 0.373675 +-0.314268 6.07153e-17 0.314268 +-0.208903 6.94431e-17 0.335247 +7.26415e-17 7.02563e-17 0.355665 +0.208903 7.19910e-17 0.335247 +0.314268 6.07153e-17 0.314268 +-0.284434 4.16334e-17 0.284434 +-0.196324 4.49944e-17 0.315742 +5.23670e-17 4.72712e-17 0.347060 +0.196324 4.16334e-17 0.315742 +0.284434 4.16334e-17 0.284434 +-0.282843 0.00000 0.282843 +-0.219089 0.00000 0.334664 +0.00000 0.00000 0.400000 +0.219089 0.00000 0.334664 +0.282843 0.00000 0.282843 +-0.385013 0.252050 0.385013 +-0.288231 0.288231 0.440280 +-4.02217e-17 0.328634 0.501996 +0.288231 0.288231 0.440280 +0.385013 0.252050 0.385013 +-0.350620 0.221967 0.350620 +-0.241179 0.241179 0.384643 +2.68882e-17 0.259938 0.418217 +0.241179 0.241179 0.384643 +0.350620 0.221967 0.350620 +-0.301862 0.190787 0.301862 +-0.200042 0.200042 0.318983 +7.11237e-17 0.208903 0.335247 +0.200042 0.200042 0.318983 +0.301862 0.190787 0.301862 +-0.268073 0.169722 0.268073 +-0.183237 0.183237 0.292142 +5.72459e-17 0.196324 0.315742 +0.183237 0.183237 0.292142 +0.268073 0.169722 0.268073 +-0.256676 0.168034 0.256676 +-0.192154 0.192154 0.293520 +2.01108e-17 0.219089 0.334664 +0.192154 0.192154 0.293520 +0.256676 0.168034 0.256676 +-0.346410 0.346410 0.346410 +-0.252050 0.385013 0.385013 +0.00000 0.424264 0.424264 +0.252050 0.385013 0.385013 +0.346410 0.346410 0.346410 +-0.326472 0.326472 0.326472 +-0.221967 0.350620 0.350620 +3.55618e-17 0.373675 0.373675 +0.221967 0.350620 0.350620 +0.326472 0.326472 0.326472 +-0.288675 0.288675 0.288675 +-0.190787 0.301862 0.301862 +6.24500e-17 0.314268 0.314268 +0.190787 0.301862 0.301862 +0.288675 0.288675 0.288675 +-0.250879 0.250879 0.250879 +-0.169722 0.268073 0.268073 +4.16334e-17 0.284434 0.284434 +0.169722 0.268073 0.268073 +0.250879 0.250879 0.250879 +-0.230940 0.230940 0.230940 +-0.168034 0.256676 0.256676 +0.00000 0.282843 0.282843 +0.168034 0.256676 0.256676 +0.230940 0.230940 0.230940 + +-0.346410 -0.346410 -0.346410 +-0.326472 -0.326472 -0.326472 +-0.288675 -0.288675 -0.288675 +-0.250879 -0.250879 -0.250879 +-0.230940 -0.230940 -0.230940 +-0.385013 -0.252050 -0.385013 +-0.350620 -0.221967 -0.350620 +-0.301862 -0.190787 -0.301862 +-0.268073 -0.169722 -0.268073 +-0.256676 -0.168034 -0.256676 +-0.424264 0.00000 -0.424264 +-0.373675 3.85976e-17 -0.373675 +-0.314268 6.07153e-17 -0.314268 +-0.284434 4.16334e-17 -0.284434 +-0.282843 0.00000 -0.282843 +-0.385013 0.252050 -0.385013 +-0.350620 0.221967 -0.350620 +-0.301862 0.190787 -0.301862 +-0.268073 0.169722 -0.268073 +-0.256676 0.168034 -0.256676 +-0.346410 0.346410 -0.346410 +-0.326472 0.326472 -0.326472 +-0.288675 0.288675 -0.288675 +-0.250879 0.250879 -0.250879 +-0.230940 0.230940 -0.230940 +-0.385013 -0.385013 -0.252050 +-0.350620 -0.350620 -0.221967 +-0.301862 -0.301862 -0.190787 +-0.268073 -0.268073 -0.169722 +-0.256676 -0.256676 -0.168034 +-0.440280 -0.288231 -0.288231 +-0.384643 -0.241179 -0.241179 +-0.318983 -0.200042 -0.200042 +-0.292142 -0.183237 -0.183237 +-0.293520 -0.192154 -0.192154 +-0.501996 0.00000 -0.328634 +-0.418217 5.06424e-17 -0.259938 +-0.335247 6.55400e-17 -0.208903 +-0.315742 4.11997e-17 -0.196324 +-0.334664 0.00000 -0.219089 +-0.440280 0.288231 -0.288231 +-0.384643 0.241179 -0.241179 +-0.318983 0.200042 -0.200042 +-0.292142 0.183237 -0.183237 +-0.293520 0.192154 -0.192154 +-0.385013 0.385013 -0.252050 +-0.350620 0.350620 -0.221967 +-0.301862 0.301862 -0.190787 +-0.268073 0.268073 -0.169722 +-0.256676 0.256676 -0.168034 +-0.424264 -0.424264 0.00000 +-0.373675 -0.373675 3.55618e-17 +-0.314268 -0.314268 6.24500e-17 +-0.284434 -0.284434 4.16334e-17 +-0.282843 -0.282843 0.00000 +-0.501996 -0.328634 -5.02771e-18 +-0.418217 -0.259938 5.29633e-17 +-0.335247 -0.208903 6.98226e-17 +-0.315742 -0.196324 4.64039e-17 +-0.334664 -0.219089 0.00000 +-0.600000 0.00000 0.00000 +-0.463353 5.41017e-17 5.24754e-17 +-0.355665 7.87131e-17 6.54858e-17 +-0.347060 4.75965e-17 5.33427e-17 +-0.400000 0.00000 0.00000 +-0.501996 0.328634 -4.02217e-17 +-0.418217 0.259938 2.66714e-17 +-0.335247 0.208903 6.59195e-17 +-0.315742 0.196324 5.63785e-17 +-0.334664 0.219089 2.01108e-17 +-0.424264 0.424264 0.00000 +-0.373675 0.373675 3.55618e-17 +-0.314268 0.314268 6.24500e-17 +-0.284434 0.284434 4.16334e-17 +-0.282843 0.282843 0.00000 +-0.385013 -0.385013 0.252050 +-0.350620 -0.350620 0.221967 +-0.301862 -0.301862 0.190787 +-0.268073 -0.268073 0.169722 +-0.256676 -0.256676 0.168034 +-0.440280 -0.288231 0.288231 +-0.384643 -0.241179 0.241179 +-0.318983 -0.200042 0.200042 +-0.292142 -0.183237 0.183237 +-0.293520 -0.192154 0.192154 +-0.501996 0.00000 0.328634 +-0.418217 4.25549e-17 0.259938 +-0.335247 7.02563e-17 0.208903 +-0.315742 4.59702e-17 0.196324 +-0.334664 0.00000 0.219089 +-0.440280 0.288231 0.288231 +-0.384643 0.241179 0.241179 +-0.318983 0.200042 0.200042 +-0.292142 0.183237 0.183237 +-0.293520 0.192154 0.192154 +-0.385013 0.385013 0.252050 +-0.350620 0.350620 0.221967 +-0.301862 0.301862 0.190787 +-0.268073 0.268073 0.169722 +-0.256676 0.256676 0.168034 +-0.346410 -0.346410 0.346410 +-0.326472 -0.326472 0.326472 +-0.288675 -0.288675 0.288675 +-0.250879 -0.250879 0.250879 +-0.230940 -0.230940 0.230940 +-0.385013 -0.252050 0.385013 +-0.350620 -0.221967 0.350620 +-0.301862 -0.190787 0.301862 +-0.268073 -0.169722 0.268073 +-0.256676 -0.168034 0.256676 +-0.424264 0.00000 0.424264 +-0.373675 3.85976e-17 0.373675 +-0.314268 6.07153e-17 0.314268 +-0.284434 4.16334e-17 0.284434 +-0.282843 0.00000 0.282843 +-0.385013 0.252050 0.385013 +-0.350620 0.221967 0.350620 +-0.301862 0.190787 0.301862 +-0.268073 0.169722 0.268073 +-0.256676 0.168034 0.256676 +-0.346410 0.346410 0.346410 +-0.326472 0.326472 0.326472 +-0.288675 0.288675 0.288675 +-0.250879 0.250879 0.250879 +-0.230940 0.230940 0.230940 + +-0.346410 -0.346410 -0.346410 +-0.252050 -0.385013 -0.385013 +0.00000 -0.424264 -0.424264 +0.252050 -0.385013 -0.385013 +0.346410 -0.346410 -0.346410 +-0.326472 -0.326472 -0.326472 +-0.221967 -0.350620 -0.350620 +3.55618e-17 -0.373675 -0.373675 +0.221967 -0.350620 -0.350620 +0.326472 -0.326472 -0.326472 +-0.288675 -0.288675 -0.288675 +-0.190787 -0.301862 -0.301862 +6.24500e-17 -0.314268 -0.314268 +0.190787 -0.301862 -0.301862 +0.288675 -0.288675 -0.288675 +-0.250879 -0.250879 -0.250879 +-0.169722 -0.268073 -0.268073 +4.16334e-17 -0.284434 -0.284434 +0.169722 -0.268073 -0.268073 +0.250879 -0.250879 -0.250879 +-0.230940 -0.230940 -0.230940 +-0.168034 -0.256676 -0.256676 +0.00000 -0.282843 -0.282843 +0.168034 -0.256676 -0.256676 +0.230940 -0.230940 -0.230940 +-0.385013 -0.385013 -0.252050 +-0.288231 -0.440280 -0.288231 +-5.02771e-18 -0.501996 -0.328634 +0.288231 -0.440280 -0.288231 +0.385013 -0.385013 -0.252050 +-0.350620 -0.350620 -0.221967 +-0.241179 -0.384643 -0.241179 +5.35223e-17 -0.418217 -0.259938 +0.241179 -0.384643 -0.241179 +0.350620 -0.350620 -0.221967 +-0.301862 -0.301862 -0.190787 +-0.200042 -0.318983 -0.200042 +6.08780e-17 -0.335247 -0.208903 +0.200042 -0.318983 -0.200042 +0.301862 -0.301862 -0.190787 +-0.268073 -0.268073 -0.169722 +-0.183237 -0.292142 -0.183237 +4.38018e-17 -0.315742 -0.196324 +0.183237 -0.292142 -0.183237 +0.268073 -0.268073 -0.169722 +-0.256676 -0.256676 -0.168034 +-0.192154 -0.293520 -0.192154 +0.00000 -0.334664 -0.219089 +0.192154 -0.293520 -0.192154 +0.256676 -0.256676 -0.168034 +-0.424264 -0.424264 0.00000 +-0.328634 -0.501996 0.00000 +0.00000 -0.600000 0.00000 +0.328634 -0.501996 0.00000 +0.424264 -0.424264 0.00000 +-0.373675 -0.373675 3.85976e-17 +-0.259938 -0.418217 5.88451e-17 +5.25296e-17 -0.463353 6.22874e-17 +0.259938 -0.418217 4.66207e-17 +0.373675 -0.373675 3.85976e-17 +-0.314268 -0.314268 6.07153e-17 +-0.208903 -0.335247 6.94431e-17 +7.26415e-17 -0.355665 7.02563e-17 +0.208903 -0.335247 7.19910e-17 +0.314268 -0.314268 6.07153e-17 +-0.284434 -0.284434 4.16334e-17 +-0.196324 -0.315742 4.15249e-17 +5.23670e-17 -0.347060 4.72712e-17 +0.196324 -0.315742 4.16334e-17 +0.284434 -0.284434 4.16334e-17 +-0.282843 -0.282843 0.00000 +-0.219089 -0.334664 0.00000 +0.00000 -0.400000 0.00000 +0.219089 -0.334664 0.00000 +0.282843 -0.282843 0.00000 +-0.385013 -0.385013 0.252050 +-0.288231 -0.440280 0.288231 +-4.02217e-17 -0.501996 0.328634 +0.288231 -0.440280 0.288231 +0.385013 -0.385013 0.252050 +-0.350620 -0.350620 0.221967 +-0.241179 -0.384643 0.241179 +2.68882e-17 -0.418217 0.259938 +0.241179 -0.384643 0.241179 +0.350620 -0.350620 0.221967 +-0.301862 -0.301862 0.190787 +-0.200042 -0.318983 0.200042 +7.11237e-17 -0.335247 0.208903 +0.200042 -0.318983 0.200042 +0.301862 -0.301862 0.190787 +-0.268073 -0.268073 0.169722 +-0.183237 -0.292142 0.183237 +5.72459e-17 -0.315742 0.196324 +0.183237 -0.292142 0.183237 +0.268073 -0.268073 0.169722 +-0.256676 -0.256676 0.168034 +-0.192154 -0.293520 0.192154 +2.01108e-17 -0.334664 0.219089 +0.192154 -0.293520 0.192154 +0.256676 -0.256676 0.168034 +-0.346410 -0.346410 0.346410 +-0.252050 -0.385013 0.385013 +0.00000 -0.424264 0.424264 +0.252050 -0.385013 0.385013 +0.346410 -0.346410 0.346410 +-0.326472 -0.326472 0.326472 +-0.221967 -0.350620 0.350620 +3.55618e-17 -0.373675 0.373675 +0.221967 -0.350620 0.350620 +0.326472 -0.326472 0.326472 +-0.288675 -0.288675 0.288675 +-0.190787 -0.301862 0.301862 +6.24500e-17 -0.314268 0.314268 +0.190787 -0.301862 0.301862 +0.288675 -0.288675 0.288675 +-0.250879 -0.250879 0.250879 +-0.169722 -0.268073 0.268073 +4.16334e-17 -0.284434 0.284434 +0.169722 -0.268073 0.268073 +0.250879 -0.250879 0.250879 +-0.230940 -0.230940 0.230940 +-0.168034 -0.256676 0.256676 +0.00000 -0.282843 0.282843 +0.168034 -0.256676 0.256676 +0.230940 -0.230940 0.230940 + +-0.346410 0.346410 -0.346410 +-0.326472 0.326472 -0.326472 +-0.288675 0.288675 -0.288675 +-0.250879 0.250879 -0.250879 +-0.230940 0.230940 -0.230940 +-0.252050 0.385013 -0.385013 +-0.221967 0.350620 -0.350620 +-0.190787 0.301862 -0.301862 +-0.169722 0.268073 -0.268073 +-0.168034 0.256676 -0.256676 +0.00000 0.424264 -0.424264 +3.85976e-17 0.373675 -0.373675 +6.07153e-17 0.314268 -0.314268 +4.16334e-17 0.284434 -0.284434 +0.00000 0.282843 -0.282843 +0.252050 0.385013 -0.385013 +0.221967 0.350620 -0.350620 +0.190787 0.301862 -0.301862 +0.169722 0.268073 -0.268073 +0.168034 0.256676 -0.256676 +0.346410 0.346410 -0.346410 +0.326472 0.326472 -0.326472 +0.288675 0.288675 -0.288675 +0.250879 0.250879 -0.250879 +0.230940 0.230940 -0.230940 +-0.385013 0.385013 -0.252050 +-0.350620 0.350620 -0.221967 +-0.301862 0.301862 -0.190787 +-0.268073 0.268073 -0.169722 +-0.256676 0.256676 -0.168034 +-0.288231 0.440280 -0.288231 +-0.241179 0.384643 -0.241179 +-0.200042 0.318983 -0.200042 +-0.183237 0.292142 -0.183237 +-0.192154 0.293520 -0.192154 +0.00000 0.501996 -0.328634 +5.06424e-17 0.418217 -0.259938 +6.55400e-17 0.335247 -0.208903 +4.11997e-17 0.315742 -0.196324 +0.00000 0.334664 -0.219089 +0.288231 0.440280 -0.288231 +0.241179 0.384643 -0.241179 +0.200042 0.318983 -0.200042 +0.183237 0.292142 -0.183237 +0.192154 0.293520 -0.192154 +0.385013 0.385013 -0.252050 +0.350620 0.350620 -0.221967 +0.301862 0.301862 -0.190787 +0.268073 0.268073 -0.169722 +0.256676 0.256676 -0.168034 +-0.424264 0.424264 0.00000 +-0.373675 0.373675 3.55618e-17 +-0.314268 0.314268 6.24500e-17 +-0.284434 0.284434 4.16334e-17 +-0.282843 0.282843 0.00000 +-0.328634 0.501996 -5.02771e-18 +-0.259938 0.418217 5.29633e-17 +-0.208903 0.335247 6.98226e-17 +-0.196324 0.315742 4.64039e-17 +-0.219089 0.334664 0.00000 +0.00000 0.600000 0.00000 +5.41017e-17 0.463353 5.24754e-17 +7.87131e-17 0.355665 6.54858e-17 +4.75965e-17 0.347060 5.33427e-17 +0.00000 0.400000 0.00000 +0.328634 0.501996 -4.02217e-17 +0.259938 0.418217 2.66714e-17 +0.208903 0.335247 6.59195e-17 +0.196324 0.315742 5.63785e-17 +0.219089 0.334664 2.01108e-17 +0.424264 0.424264 0.00000 +0.373675 0.373675 3.55618e-17 +0.314268 0.314268 6.24500e-17 +0.284434 0.284434 4.16334e-17 +0.282843 0.282843 0.00000 +-0.385013 0.385013 0.252050 +-0.350620 0.350620 0.221967 +-0.301862 0.301862 0.190787 +-0.268073 0.268073 0.169722 +-0.256676 0.256676 0.168034 +-0.288231 0.440280 0.288231 +-0.241179 0.384643 0.241179 +-0.200042 0.318983 0.200042 +-0.183237 0.292142 0.183237 +-0.192154 0.293520 0.192154 +0.00000 0.501996 0.328634 +4.25549e-17 0.418217 0.259938 +7.02563e-17 0.335247 0.208903 +4.59702e-17 0.315742 0.196324 +0.00000 0.334664 0.219089 +0.288231 0.440280 0.288231 +0.241179 0.384643 0.241179 +0.200042 0.318983 0.200042 +0.183237 0.292142 0.183237 +0.192154 0.293520 0.192154 +0.385013 0.385013 0.252050 +0.350620 0.350620 0.221967 +0.301862 0.301862 0.190787 +0.268073 0.268073 0.169722 +0.256676 0.256676 0.168034 +-0.346410 0.346410 0.346410 +-0.326472 0.326472 0.326472 +-0.288675 0.288675 0.288675 +-0.250879 0.250879 0.250879 +-0.230940 0.230940 0.230940 +-0.252050 0.385013 0.385013 +-0.221967 0.350620 0.350620 +-0.190787 0.301862 0.301862 +-0.169722 0.268073 0.268073 +-0.168034 0.256676 0.256676 +0.00000 0.424264 0.424264 +3.85976e-17 0.373675 0.373675 +6.07153e-17 0.314268 0.314268 +4.16334e-17 0.284434 0.284434 +0.00000 0.282843 0.282843 +0.252050 0.385013 0.385013 +0.221967 0.350620 0.350620 +0.190787 0.301862 0.301862 +0.169722 0.268073 0.268073 +0.168034 0.256676 0.256676 +0.346410 0.346410 0.346410 +0.326472 0.326472 0.326472 +0.288675 0.288675 0.288675 +0.250879 0.250879 0.250879 +0.230940 0.230940 0.230940 + + -- 2.39.5