]> https://gitweb.dealii.org/ - dealii.git/commitdiff
SmoothnessEstimator: Enhancements regarding applicability.
authorMarc Fehling <marc.fehling@gmx.net>
Mon, 7 Jan 2019 12:00:03 +0000 (13:00 +0100)
committerMarc Fehling <marc.fehling@gmx.net>
Tue, 12 May 2020 14:03:28 +0000 (16:03 +0200)
41 files changed:
doc/doxygen/references.bib
doc/news/changes/incompatibilities/20200122Fehling [new file with mode: 0644]
doc/news/changes/major/20191030FehlingDavydov [new file with mode: 0644]
doc/news/changes/minor/20181227DenisDavydov
doc/news/changes/minor/20191030Fehling [new file with mode: 0644]
doc/news/changes/minor/20200121Fehling-1 [new file with mode: 0644]
doc/news/changes/minor/20200121Fehling-2 [new file with mode: 0644]
examples/step-27/doc/intro.dox
examples/step-27/step-27.cc
include/deal.II/fe/fe_series.h
include/deal.II/hp/fe_collection.h
include/deal.II/numerics/smoothness_estimator.h
include/deal.II/numerics/smoothness_estimator.templates.h [deleted file]
source/fe/fe_series_fourier.cc
source/fe/fe_series_legendre.cc
source/hp/refinement.cc
source/numerics/CMakeLists.txt
source/numerics/smoothness_estimator.cc
source/numerics/smoothness_estimator.inst.in
tests/fe/fe_series_01.cc
tests/fe/fe_series_02.cc
tests/fe/fe_series_03.output
tests/fe/fe_series_04.cc
tests/fe/fe_series_05.cc
tests/fe/fe_series_06.cc
tests/fe/fe_series_07.output
tests/hp/laplace.h
tests/hp/laplace_mitchel2014_04_peak.output [deleted file]
tests/hp/laplace_mitchell2014_04_peak.cc [moved from tests/hp/laplace_mitchel2014_04_peak.cc with 78% similarity]
tests/hp/laplace_mitchell2014_04_peak.with_trilinos=true.output [new file with mode: 0644]
tests/hp/step-27.cc
tests/mpi/petsc_step-27.cc
tests/mpi/trilinos_step-27.cc
tests/numerics/smoothness_estimator_01.cc
tests/numerics/smoothness_estimator_01.with_gsl=on.output
tests/numerics/smoothness_estimator_02.cc [new file with mode: 0644]
tests/numerics/smoothness_estimator_02.output [new file with mode: 0644]
tests/serialization/fe_series_01.cc
tests/serialization/fe_series_01.output
tests/serialization/fe_series_02.cc
tests/serialization/fe_series_02.with_gsl=on.output

index 3df58194b8aaf290ef8c368af8239365896680de..e4d9a420ad91ead957c929f28d0bc90e48295b69 100644 (file)
@@ -715,6 +715,77 @@ year = {2008},
   Address                  = {University of Minnesota},
   Number                   = {91-279},
   Url                      = {citeseer.ist.psu.edu/saad93flexible.html}
+
+@article{ainsworth1998hp,
+  author    = {Ainsworth, Mark and Senior, Bill},
+  title     = {An adaptive refinement strategy for hp-finite element computations},
+  journal   = {{Applied Numerical Mathematics}},
+  volume    = {26},
+  number    = {1--2},
+  pages     = {165--178},
+  publisher = {Elsevier},
+  year      = {1998},
+  doi       = {10.1016/S0168-9274(97)00083-4}
+}
+
+@article{melenk2001hp,
+  author    = {Melenk, Jens Markus and Wohlmuth, Barbara I.},
+  title     = {{On residual-based a posteriori error estimation in hp-FEM}},
+  journal   = {{Advances in Computational Mathematics}},
+  volume    = {15},
+  number    = {1},
+  pages     = {311--331},
+  publisher = {Springer US},
+  year      = {2001},
+  doi       = {10.1023/A:1014268310921}
+}
+
+@article{mavriplis1994hp,
+  author    = {Mavriplis, Catherine},
+  title     = {Adaptive mesh strategies for the spectral element method},
+  journal   = {{Computer Methods in Applied Mechanics and Engineering}},
+  year      = {1994},
+  volume    = {116},
+  number    = {1},
+  pages     = {77--86},
+  publisher = {Elsevier},
+  doi       = {10.1016/S0045-7825(94)80010-3}
+}
+
+@article{houston2005hp,
+  author    = {Houston, Paul and S{\"u}li, Endre},
+  title     = {A note on the design of hp-adaptive finite element methods for elliptic partial differential equations},
+  journal   = {{Computer Methods in Applied Mechanics and Engineering}},
+  number    = {2},
+  pages     = {229--243},
+  publisher = {Elsevier},
+  volume    = {194},
+  year      = {2005},
+  doi       = {10.1016/j.cma.2004.04.009}
+}
+
+@article{eibner2007hp,
+  author    = {Eibner, Tino and Melenk, Jens Markus},
+  title     = {{An adaptive strategy for hp-FEM based on testing for analyticity}},
+  journal   = {{Computational Mechanics}},
+  year      = {2007},
+  volume    = {39},
+  number    = {5},
+  pages     = {575--595},
+  publisher = {Springer},
+  doi       = {10.1007/s00466-006-0107-0}
+}
+
+@article{davydov2017hp,
+  author  = {Davydov, Denis and Gerasimov, Tymofiy and Pelteret, Jean-Paul and Steinmann, Paul},
+  title   = {{Convergence study of the h-adaptive PUM and the hp-adaptive FEM applied to eigenvalue problems in quantum mechanics}},
+  journal = {{Advanced Modeling and Simulation in Engineering Sciences}},
+  year    = {2017},
+  volume  = {4},
+  number  = {1},
+  pages   = {7},
+  issn    = {2213-7467},
+  doi     = {10.1186/s40323-017-0093-0}
 }
 
 @Article{clevenger_par_gmg,
diff --git a/doc/news/changes/incompatibilities/20200122Fehling b/doc/news/changes/incompatibilities/20200122Fehling
new file mode 100644 (file)
index 0000000..2905eb5
--- /dev/null
@@ -0,0 +1,5 @@
+Changed: FESeries::Fourier and FESeries::Legendre now require to use an
+individual number of coefficients per direction for each finite element
+registered in the provided FECollection.
+<br>
+(Marc Fehling, 2020/01/22)
diff --git a/doc/news/changes/major/20191030FehlingDavydov b/doc/news/changes/major/20191030FehlingDavydov
new file mode 100644 (file)
index 0000000..192d2cf
--- /dev/null
@@ -0,0 +1,4 @@
+New: Namespace SmoothnessEstimator providing smoothness estimation strategies
+for hp-adaptive FEM based on Fourier and Legendre series expansions.
+<br>
+(Marc Fehling, Denis Davydov, 2019/10/30)
index b45077c2c9c8f0605ba5d99946a8f07c8570c342..88a2c69b27d60c662eeca92376884fa2d6a0d59b 100644 (file)
@@ -1,6 +1,7 @@
-New: Add FESeries::Legendre::get_size_in_each_direction() to retrieve
+New: Add FESeries::Legendre::get_n_coefficients_per_direction() and
+FESeries::Fourier::get_n_coefficients_per_direction() to retrieve
 the number of coefficients in each direction. Also add an Assert in
-FESeries::Legendre::calculate() to check the dimension of the table to store
-coefficients.
+FESeries::Legendre::calculate() and FESeries::Fourier::calculate() to
+check the dimension of the table to store coefficients.
 <br>
 (Denis Davydov, 2018/12/27)
diff --git a/doc/news/changes/minor/20191030Fehling b/doc/news/changes/minor/20191030Fehling
new file mode 100644 (file)
index 0000000..09d88a1
--- /dev/null
@@ -0,0 +1,4 @@
+New: Member function hp::FECollection::max_degree() that returns the
+maximal polynomial degree of all finite elements in the collection.
+<br>
+(Marc Fehling, 2019/10/30)
diff --git a/doc/news/changes/minor/20200121Fehling-1 b/doc/news/changes/minor/20200121Fehling-1
new file mode 100644 (file)
index 0000000..15f4f7d
--- /dev/null
@@ -0,0 +1,4 @@
+New: Both classes FESeries::Fourier and FESeries::Legendre now offer a
+default constructor and can be initialized after their instantiation.
+<br>
+(Marc Fehling, 2020/01/21)
diff --git a/doc/news/changes/minor/20200121Fehling-2 b/doc/news/changes/minor/20200121Fehling-2
new file mode 100644 (file)
index 0000000..7a13044
--- /dev/null
@@ -0,0 +1,4 @@
+New: FESeries::process_coefficients() now allows to ignore coefficients
+below an absolute threshold, which has to be provided as a parameter.
+<br>
+(Marc Fehling, 2020/01/21)
index 9e1cca1b6845ff82b92e6ad0a9216bfc49e14d58..0597da67891a27f40f6045b82c60b51977435c43 100644 (file)
@@ -367,7 +367,7 @@ and see how fast they decay. If they decay as
 then consequently the function we had here was in $H^{\mu-d/2}$.
 
 
-<h4>What has to be done</h4>
+<h4>What we have to do</h4>
 
 So what do we have to do to estimate the local smoothness of $u({\bf x})$ on
 a cell $K$? Clearly, the first step is to compute the Fourier coefficients
@@ -403,9 +403,9 @@ cell. In other words, we can write it as a matrix-vector product
 @f]
 with the matrix
 @f[
-   {\cal F}_{{\bf k},j}
-   =
-   \int_{\hat K} e^{i {\bf k}\cdot \hat{\bf x}} \hat \varphi_j(\hat{\bf x}) d\hat{\bf x}.
+        {\cal F}_{{\bf k},j}
+        =
+        \int_{\hat K} e^{i {\bf k}\cdot \hat{\bf x}} \hat \varphi_j(\hat{\bf x}) d\hat{\bf x}.
 @f]
 This matrix is easily computed for a given number of shape functions
 $\varphi_j$ and Fourier modes $N$. Consequently, finding the
@@ -509,10 +509,6 @@ $\beta$, the formula above gives us a mean to calculate the value of
 the exponent $\mu$ that we can then use to determine that
 $\hat u(\hat{\bf x})$ is in $H^s(\hat K)$ with $s=\mu-\frac d2$.
 
-These steps outlined above are applicable on many different scenarios, which
-motivated the introduction of a generic function
-SmoothnessEstimator::estimate_by_coefficient_decay() in deal.II, that combines all
-the tasks described in this section in one simple function call.
 
 <h4>Compensating for anisotropy</h4>
 
index 39cad4e1408c91989118cdd430f0133eacdb6890..70d163efdb2b58d7e495430fa00f30a54034b97b 100644 (file)
 
 // These are the new files we need. The first and second provide <i>hp</i>
 // versions of the DoFHandler and FEValues classes as described in the
-// introduction of this program. The last one provides the smoothness estimation
-// algorithms on decaying series expansion coefficients.
+// introduction of this program. The last one provides Fourier transformation
+// class on the unit cell.
 #include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_values.h>
-#include <deal.II/numerics/smoothness_estimator.h>
+#include <deal.II/fe/fe_series.h>
 
 // The last set of include files are standard C++ headers. We need support for
 // complex numbers when we compute the Fourier transform.
@@ -99,7 +99,9 @@ namespace Step27
     void assemble_system();
     void solve();
     void create_coarse_grid();
+    void estimate_smoothness(Vector<float> &smoothness_indicators);
     void postprocess(const unsigned int cycle);
+    std::pair<bool, unsigned int> predicate(const TableIndices<dim> &indices);
 
     Triangulation<dim> triangulation;
 
@@ -108,6 +110,11 @@ namespace Step27
     hp::QCollection<dim>     quadrature_collection;
     hp::QCollection<dim - 1> face_quadrature_collection;
 
+    hp::QCollection<dim>             fourier_q_collection;
+    FESeries::Fourier<dim>           fourier;
+    std::vector<double>              ln_k;
+    Table<dim, std::complex<double>> fourier_coefficients;
+
     AffineConstraints<double> constraints;
 
     SparsityPattern      sparsity_pattern;
@@ -160,6 +167,23 @@ namespace Step27
   // face quadrature objects. We start with quadratic elements, and each
   // quadrature formula is chosen so that it is appropriate for the matching
   // finite element in the hp::FECollection object.
+  //
+  // Finally, we initialize FESeries::Fourier object which will be used to
+  // calculate coefficient in Fourier series as described in the introduction.
+  // In addition to the hp::FECollection, we need to provide quadrature rules
+  // hp::QCollection for integration on the reference cell.
+  //
+  // In order to resize fourier_coefficients Table, we use the following
+  // auxiliary function
+  template <int dim, typename T>
+  void resize(Table<dim, T> &coeff, const unsigned int N)
+  {
+    TableIndices<dim> size;
+    for (unsigned int d = 0; d < dim; d++)
+      size[d] = N;
+    coeff.reinit(size);
+  }
+
   template <int dim>
   LaplaceProblem<dim>::LaplaceProblem()
     : dof_handler(triangulation)
@@ -171,6 +195,50 @@ namespace Step27
         quadrature_collection.push_back(QGauss<dim>(degree + 1));
         face_quadrature_collection.push_back(QGauss<dim - 1>(degree + 1));
       }
+
+    // As described in the introduction, we define the Fourier vectors ${\bf
+    // k}$ for which we want to compute Fourier coefficients of the solution
+    // on each cell as follows. In 2d, we will need coefficients corresponding
+    // to vectors ${\bf k}=(2 \pi i, 2\pi j)^T$ for which $\sqrt{i^2+j^2}\le N$,
+    // with $i,j$ integers and $N$ being the maximal polynomial degree we use
+    // for the finite elements in this program. The FESeries::Fourier class'
+    // constructor first parameter $N$ defines the number of coefficients in 1D
+    // with the total number of coefficients being $N^{dim}$. Although we will
+    // not use coefficients corresponding to
+    // $\sqrt{i^2+j^2}> N$ and $i+j==0$, the overhead of their calculation is
+    // minimal. The transformation matrices for each FiniteElement will be
+    // calculated only once the first time they are required in the course of
+    // hp-adaptive refinement. Because we work on the unit cell, we can do all
+    // this work without a mapping from reference to real cell and consequently
+    // can precalculate these matrices. The calculation of expansion
+    // coefficients for a particular set of local degrees of freedom on a given
+    // cell then follows as a simple matrix-vector product.
+    // The 3d case is handled analogously.
+    const unsigned int N = max_degree;
+
+    // We will need to assemble the matrices that do the Fourier transforms
+    // for each of the finite elements we deal with, i.e. the matrices ${\cal
+    // F}_{{\bf k},j}$ defined in the introduction. We have to do that for
+    // each of the finite elements in use. To that end we need a quadrature
+    // rule. In this example we use the same quadrature formula for each
+    // finite element, namely that is obtained by iterating a
+    // 2-point Gauss formula as many times as the maximal exponent we use for
+    // the term $e^{i{\bf k}\cdot{\bf x}}$:
+    QGauss<1>      base_quadrature(2);
+    QIterated<dim> quadrature(base_quadrature, N);
+    for (unsigned int i = 0; i < fe_collection.size(); i++)
+      fourier_q_collection.push_back(quadrature);
+
+    // Now we are ready to set-up the FESeries::Fourier object
+    const std::vector<unsigned int> n_coefficients_per_direction(
+      fe_collection.size(), N);
+    fourier.initialize(n_coefficients_per_direction,
+                       fe_collection,
+                       fourier_q_collection);
+
+    // We need to resize the matrix of fourier coefficients according to the
+    // number of modes N.
+    resize(fourier_coefficients, N);
   }
 
 
@@ -337,7 +405,8 @@ namespace Step27
     // Let us start with computing estimated error and smoothness indicators,
     // which each are one number for each active cell of our
     // triangulation. For the error indicator, we use the KellyErrorEstimator
-    // class as always.
+    // class as always. Estimating the smoothness is done in the respective
+    // function of this class; that function is discussed further down below:
     Vector<float> estimated_error_per_cell(triangulation.n_active_cells());
     KellyErrorEstimator<dim>::estimate(
       dof_handler,
@@ -346,12 +415,9 @@ namespace Step27
       solution,
       estimated_error_per_cell);
 
-    // Estimating the smoothness is performed with the method of decaing
-    // expansion coefficients as outlined in the introduction.
-    Vector<float> smoothness_indicators;
-    SmoothnessEstimator::fourier_coefficient_decay(dof_handler,
-                                                   solution,
-                                                   smoothness_indicators);
+
+    Vector<float> smoothness_indicators(triangulation.n_active_cells());
+    estimate_smoothness(smoothness_indicators);
 
     // Next we want to generate graphical output. In addition to the two
     // estimated quantities derived above, we would also like to output the
@@ -549,6 +615,118 @@ namespace Step27
         postprocess(cycle);
       }
   }
+
+
+  // @sect4{LaplaceProblem::estimate_smoothness}
+
+  // As described in the introduction, we will need to take the maximum
+  // absolute value of fourier coefficients which correspond to $k$-vector
+  // $|{\bf k}|= const$. To filter the coefficients Table we
+  // will use the FESeries::process_coefficients() which requires a predicate
+  // to be specified. The predicate should operate on TableIndices and return
+  // a pair of <code>bool</code> and <code>unsigned int</code>. The latter
+  // is the value of the map from TableIndicies to unsigned int.  It is
+  // used to define subsets of coefficients from which we search for the one
+  // with highest absolute value, i.e. $l^\infty$-norm. The <code>bool</code>
+  // parameter defines which indices should be used in processing. In the
+  // current case we are interested in coefficients which correspond to
+  // $0 < i*i+j*j < N*N$ and $0 < i*i+j*j+k*k < N*N$ in 2D and 3D, respectively.
+  template <int dim>
+  std::pair<bool, unsigned int>
+  LaplaceProblem<dim>::predicate(const TableIndices<dim> &ind)
+  {
+    unsigned int v = 0;
+    for (unsigned int i = 0; i < dim; i++)
+      v += ind[i] * ind[i];
+    if (v > 0 && v < max_degree * max_degree)
+      return std::make_pair(true, v);
+    else
+      return std::make_pair(false, v);
+  }
+
+  // This last function of significance implements the algorithm to estimate
+  // the smoothness exponent using the algorithms explained in detail in the
+  // introduction. We will therefore only comment on those points that are of
+  // implementational importance.
+  template <int dim>
+  void
+  LaplaceProblem<dim>::estimate_smoothness(Vector<float> &smoothness_indicators)
+  {
+    // Since most of the hard work is done for us in FESeries::Fourier and
+    // we set up the object of this class in the constructor, what we are left
+    // to do here is apply this class to calculate coefficients and then
+    // perform linear regression to fit their decay slope.
+
+
+    // First thing to do is to loop over all cells and do our work there, i.e.
+    // to locally do the Fourier transform and estimate the decay coefficient.
+    // We will use the following array as a scratch array in the loop to store
+    // local DoF values:
+    Vector<double> local_dof_values;
+
+    // Then here is the loop:
+    for (const auto &cell : dof_handler.active_cell_iterators())
+      {
+        // Inside the loop, we first need to get the values of the local
+        // degrees of freedom (which we put into the
+        // <code>local_dof_values</code> array after setting it to the right
+        // size) and then need to compute the Fourier transform by multiplying
+        // this vector with the matrix ${\cal F}$ corresponding to this finite
+        // element. This is done by calling FESeries::Fourier::calculate(),
+        // that has to be provided with the <code>local_dof_values</code>,
+        // <code>cell->active_fe_index()</code> and a Table to store
+        // coefficients.
+        local_dof_values.reinit(cell->get_fe().dofs_per_cell);
+        cell->get_dof_values(solution, local_dof_values);
+
+        fourier.calculate(local_dof_values,
+                          cell->active_fe_index(),
+                          fourier_coefficients);
+
+        // The next thing, as explained in the introduction, is that we wanted
+        // to only fit our exponential decay of Fourier coefficients to the
+        // largest coefficients for each possible value of $|{\bf k}|$. To
+        // this end, we use FESeries::process_coefficients() to rework
+        // coefficients into the desired format. We'll only take those Fourier
+        // coefficients with the largest magnitude for a given value of $|{\bf
+        // k}|$ and thereby need to use VectorTools::Linfty_norm:
+        std::pair<std::vector<unsigned int>, std::vector<double>> res =
+          FESeries::process_coefficients<dim>(
+            fourier_coefficients,
+            [this](const TableIndices<dim> &indices) {
+              return this->predicate(indices);
+            },
+            VectorTools::Linfty_norm);
+
+        Assert(res.first.size() == res.second.size(), ExcInternalError());
+
+        // The first vector in the <code>std::pair</code> will store values of
+        // the predicate, that is $i*i+j*j= const$ or $i*i+j*j+k*k = const$ in
+        // 2D or 3D respectively. This vector will be the same for all the cells
+        // so we can calculate logarithms of the corresponding Fourier vectors
+        // $|{\bf k}|$ only once in the whole hp-refinement cycle:
+        if (ln_k.size() == 0)
+          {
+            ln_k.resize(res.first.size(), 0);
+            for (unsigned int f = 0; f < ln_k.size(); f++)
+              ln_k[f] =
+                std::log(2.0 * numbers::PI * std::sqrt(1. * res.first[f]));
+          }
+
+        // We have to calculate the logarithms of absolute values of
+        // coefficients and use it in a linear regression fit to obtain $\mu$.
+        for (double &residual_element : res.second)
+          residual_element = std::log(residual_element);
+
+        std::pair<double, double> fit =
+          FESeries::linear_regression(ln_k, res.second);
+
+        // The final step is to compute the Sobolev index $s=\mu-\frac d2$ and
+        // store it in the vector of estimated values for each cell:
+        smoothness_indicators(cell->active_cell_index()) =
+          -fit.first - 1. * dim / 2;
+      }
+  }
 } // namespace Step27
 
 
index 229604c51e3d9efa30f6b2cdeac71caddc573e05..dc4fe342342a645488e5d1c4585644f62a9b7cde 100644 (file)
@@ -13,8 +13,8 @@
 //
 // ---------------------------------------------------------------------
 
-#ifndef dealii_fe_series_H
-#define dealii_fe_series_H
+#ifndef dealii_fe_series_h
+#define dealii_fe_series_h
 
 
 
@@ -94,16 +94,50 @@ namespace FESeries
     using CoefficientType = typename std::complex<double>;
 
     /**
-     * A non-default constructor. The @p size_in_each_direction defines the number
-     * of modes in each direction, @p fe_collection is the hp::FECollection
+     * Default constructor.
+     *
+     * Leaves all members in an empty or uninitialized state. Please call
+     * initialize() once you have all data structures ready.
+     */
+    Fourier() = default;
+
+    /**
+     * Constructor that initializes all required data structures.
+     *
+     * The @p n_coefficients_per_direction defines the number of coefficients in
+     * each direction, @p fe_collection is the hp::FECollection for which
+     * expansion will be used and @p q_collection is the hp::QCollection used to
+     * integrate the expansion for each FiniteElement in @p fe_collection.
+     */
+    Fourier(const std::vector<unsigned int> &      n_coefficients_per_direction,
+            const hp::FECollection<dim, spacedim> &fe_collection,
+            const hp::QCollection<dim> &           q_collection);
+
+    /**
+     * A non-default constructor. The @p n_coefficients_per_direction defines the
+     * number of modes in each direction, @p fe_collection is the hp::FECollection
      * for which expansion will be used and @p q_collection is the hp::QCollection
      * used to integrate the expansion for each FiniteElement
      * in @p fe_collection.
+     *
+     * @deprecated Use a different constructor instead.
      */
-    Fourier(const unsigned int                     size_in_each_direction,
+    DEAL_II_DEPRECATED
+    Fourier(const unsigned int                     n_coefficients_per_direction,
             const hp::FECollection<dim, spacedim> &fe_collection,
             const hp::QCollection<dim> &           q_collection);
 
+    /**
+     * Initialize and overwrite all mandatory data structures for the
+     * calculation calculation of transformation matrices.
+     *
+     * All previously calculated transformation matrices will be cleared.
+     */
+    void
+    initialize(const std::vector<unsigned int> &n_coefficients_per_direction,
+               const hp::FECollection<dim, spacedim> &fe_collection,
+               const hp::QCollection<dim> &           q_collection);
+
     /**
      * Calculate @p fourier_coefficients of the cell vector field given by
      * @p local_dof_values corresponding to FiniteElement with
@@ -115,6 +149,13 @@ namespace FESeries
               const unsigned int            cell_active_fe_index,
               Table<dim, CoefficientType> & fourier_coefficients);
 
+    /**
+     * Return the number of coefficients in each coordinate direction for the
+     * finite element associated with @p index in the provided hp::FECollection.
+     */
+    unsigned int
+    get_n_coefficients_per_direction(const unsigned int index) const;
+
     /**
      * Calculate all transformation matrices to transfer the finite element
      * solution to the series expansion representation.
@@ -156,6 +197,12 @@ namespace FESeries
     operator==(const Fourier<dim, spacedim> &fourier) const;
 
   private:
+    /**
+     * Number of coefficients in each direction for each finite element in the
+     * registered hp::FECollection.
+     */
+    std::vector<unsigned int> n_coefficients_per_direction;
+
     /**
      * hp::FECollection for which transformation matrices will be calculated.
      */
@@ -182,6 +229,8 @@ namespace FESeries
     std::vector<CoefficientType> unrolled_coefficients;
   };
 
+
+
   /**
    * A class to calculate expansion of a scalar FE field into series of Legendre
    * functions on a reference element.
@@ -231,17 +280,50 @@ namespace FESeries
   public:
     using CoefficientType = double;
 
+    /**
+     * Default constructor.
+     *
+     * Leaves all members in an empty or uninitialized state. Please call
+     * initialize() once you have all data structures ready.
+     */
+    Legendre() = default;
+
+    /**
+     * Constructor that initializes all required data structures.
+     *
+     * The @p n_coefficients_per_direction defines the number of coefficients in
+     * each direction, @p fe_collection is the hp::FECollection for which
+     * expansion will be used and @p q_collection is the hp::QCollection used to
+     * integrate the expansion for each FiniteElement in @p fe_collection.
+     */
+    Legendre(const std::vector<unsigned int> &n_coefficients_per_direction,
+             const hp::FECollection<dim, spacedim> &fe_collection,
+             const hp::QCollection<dim> &           q_collection);
+
     /**
      * A non-default constructor. The @p size_in_each_direction defines the number
      * of coefficients in each direction, @p fe_collection is the hp::FECollection
      * for which expansion will be used and @p q_collection is the hp::QCollection
-     * used to integrate the expansion for each FiniteElement
-     * in @p fe_collection.
+     * used to integrate the expansion for each FiniteElement in @p fe_collection.
+     *
+     * @deprecated Use a different constructor instead.
      */
-    Legendre(const unsigned int                     size_in_each_direction,
+    DEAL_II_DEPRECATED
+    Legendre(const unsigned int n_coefficients_per_direction,
              const hp::FECollection<dim, spacedim> &fe_collection,
              const hp::QCollection<dim> &           q_collection);
 
+    /**
+     * Initialize and overwrite all mandatory data structures for the
+     * calculation of transformation matrices.
+     *
+     * All previously calculated transformation matrices will be cleared.
+     */
+    void
+    initialize(const std::vector<unsigned int> &n_coefficients_per_direction,
+               const hp::FECollection<dim, spacedim> &fe_collection,
+               const hp::QCollection<dim> &           q_collection);
+
     /**
      * Calculate @p legendre_coefficients of the cell vector field given by
      * @p local_dof_values corresponding to FiniteElement with
@@ -254,10 +336,11 @@ namespace FESeries
               Table<dim, CoefficientType> & legendre_coefficients);
 
     /**
-     * Return number of coefficients in each coordinate direction.
+     * Return the number of coefficients in each coordinate direction for the
+     * finite element associated with @p index in the provided hp::FECollection.
      */
     unsigned int
-    get_size_in_each_direction() const;
+    get_n_coefficients_per_direction(const unsigned int index) const;
 
     /**
      * Calculate all transformation matrices to transfer the finite element
@@ -301,9 +384,10 @@ namespace FESeries
 
   private:
     /**
-     * Number of coefficients in each direction
+     * Number of coefficients in each direction for each finite element in the
+     * registered hp::FECollection.
      */
-    const unsigned int N;
+    std::vector<unsigned int> n_coefficients_per_direction;
 
     /**
      * hp::FECollection for which transformation matrices will be calculated.
@@ -327,6 +411,7 @@ namespace FESeries
   };
 
 
+
   /**
    * Calculate the @p norm of subsets of @p coefficients defined by
    * @p predicate being constant. Return the pair of vectors of predicate values
@@ -337,18 +422,20 @@ namespace FESeries
    * used in calculation, whereas the latter is the unrolled value of indices
    * according to which the subsets of coefficients will be formed.
    *
-   * @note Only the following values of @p norm are implemented and make sense
-   * in this case: mean, L1_norm, L2_norm, Linfty_norm. The mean norm can only
-   * be applied to real valued coefficients.
+   * Only those coefficients will be considered which are larger than
+   * @p smallest_abs_coefficient.
+   *
+   * @note Only the following values of @p norm_type are implemented and make
+   * sense in this case: mean, L1_norm, L2_norm, Linfty_norm. The mean norm ca
+   * only be applied to real valued coefficients.
    */
   template <int dim, typename CoefficientType>
   std::pair<std::vector<unsigned int>, std::vector<double>>
   process_coefficients(const Table<dim, CoefficientType> &coefficients,
                        const std::function<std::pair<bool, unsigned int>(
                          const TableIndices<dim> &)> &    predicate,
-                       const VectorTools::NormType        norm);
-
-
+                       const VectorTools::NormType        norm_type,
+                       const double smallest_abs_coefficient = 1e-10);
 
   /**
    * Linear regression least-square fit of $y = k \, x + b$.
@@ -362,6 +449,8 @@ namespace FESeries
 
 /*@}*/
 
+
+
 #ifndef DOXYGEN
 
 // -------------------  inline and template functions ----------------
@@ -391,6 +480,8 @@ namespace internal
       pred_to_values[pred_value].push_back(coeff_value);
     }
 
+
+
     template <typename CoefficientType>
     void
     fill_map(
@@ -406,6 +497,8 @@ namespace internal
         }
     }
 
+
+
     template <typename CoefficientType>
     void
     fill_map(
@@ -422,6 +515,8 @@ namespace internal
           }
     }
 
+
+
     template <typename CoefficientType>
     void
     fill_map(
@@ -440,6 +535,7 @@ namespace internal
     }
 
 
+
     template <typename Number>
     double
     complex_mean_value(const Number &value)
@@ -447,6 +543,8 @@ namespace internal
       return value;
     }
 
+
+
     template <typename Number>
     double
     complex_mean_value(const std::complex<Number> &value)
@@ -461,14 +559,19 @@ namespace internal
 } // namespace internal
 
 
+
 template <int dim, typename CoefficientType>
 std::pair<std::vector<unsigned int>, std::vector<double>>
 FESeries::process_coefficients(
   const Table<dim, CoefficientType> &coefficients,
   const std::function<std::pair<bool, unsigned int>(const TableIndices<dim> &)>
     &                         predicate,
-  const VectorTools::NormType norm)
+  const VectorTools::NormType norm_type,
+  const double                smallest_abs_coefficient)
 {
+  Assert(smallest_abs_coefficient >= 0.,
+         ExcMessage("smallest_abs_coefficient should be non-negative."));
+
   std::vector<unsigned int> predicate_values;
   std::vector<double>       norm_values;
 
@@ -483,38 +586,44 @@ FESeries::process_coefficients(
   // now go through the map and populate the @p norm_values based on @p norm:
   for (const auto &pred_to_value : pred_to_values)
     {
-      predicate_values.push_back(pred_to_value.first);
       Vector<CoefficientType> values(pred_to_value.second.cbegin(),
                                      pred_to_value.second.cend());
 
-      switch (norm)
+      double norm_value = 0;
+      switch (norm_type)
         {
           case VectorTools::L2_norm:
             {
-              norm_values.push_back(values.l2_norm());
+              norm_value = values.l2_norm();
               break;
             }
           case VectorTools::L1_norm:
             {
-              norm_values.push_back(values.l1_norm());
+              norm_value = values.l1_norm();
               break;
             }
           case VectorTools::Linfty_norm:
             {
-              norm_values.push_back(values.linfty_norm());
+              norm_value = values.linfty_norm();
               break;
             }
           case VectorTools::mean:
             {
-              norm_values.push_back(
-                internal::FESeriesImplementation::complex_mean_value(
-                  values.mean_value()));
+              norm_value = internal::FESeriesImplementation::complex_mean_value(
+                values.mean_value());
               break;
             }
           default:
             AssertThrow(false, ExcNotImplemented());
             break;
         }
+
+      // will use all non-zero coefficients
+      if (std::abs(norm_value) > smallest_abs_coefficient)
+        {
+          predicate_values.push_back(pred_to_value.first);
+          norm_values.push_back(norm_value);
+        }
     }
 
   return std::make_pair(predicate_values, norm_values);
@@ -532,12 +641,11 @@ FESeries::Fourier<dim, spacedim>::save_transformation_matrices(
   // Store information about those resources which have been used to generate
   // the transformation matrices.
   // mode vector
-  unsigned int size = k_vectors.n_elements();
-  ar &         size;
+  ar &n_coefficients_per_direction;
 
   // finite element collection
-  size = fe_collection->size();
-  ar &size;
+  unsigned int size = fe_collection->size();
+  ar &         size;
   for (unsigned int i = 0; i < size; ++i)
     ar &(*fe_collection)[i].get_name();
 
@@ -563,12 +671,16 @@ FESeries::Fourier<dim, spacedim>::load_transformation_matrices(
   // Check whether the currently registered resources are compatible with
   // the transformation matrices to load.
   // mode vector
-  unsigned int size;
-  ar &         size;
-  AssertDimension(size, k_vectors.n_elements());
+  std::vector<unsigned int> compare_coefficients;
+  ar &                      compare_coefficients;
+  Assert(compare_coefficients == n_coefficients_per_direction,
+         ExcMessage("A different number of coefficients vector has been used "
+                    "to generate the transformation matrices you are about "
+                    "to load!"));
 
   // finite element collection
-  ar &size;
+  unsigned int size;
+  ar &         size;
   AssertDimension(size, fe_collection->size());
   std::string name;
   for (unsigned int i = 0; i < size; ++i)
@@ -607,12 +719,11 @@ FESeries::Legendre<dim, spacedim>::save_transformation_matrices(
   // Store information about those resources which have been used to generate
   // the transformation matrices.
   // mode vector
-  unsigned int size = N;
-  ar &         size;
+  ar &n_coefficients_per_direction;
 
   // finite element collection
-  size = fe_collection->size();
-  ar &size;
+  unsigned int size = fe_collection->size();
+  ar &         size;
   for (unsigned int i = 0; i < size; ++i)
     ar &(*fe_collection)[i].get_name();
 
@@ -638,12 +749,16 @@ FESeries::Legendre<dim, spacedim>::load_transformation_matrices(
   // Check whether the currently registered resources are compatible with
   // the transformation matrices to load.
   // mode vector
-  unsigned int size;
-  ar &         size;
-  AssertDimension(size, N);
+  std::vector<unsigned int> compare_coefficients;
+  ar &                      compare_coefficients;
+  Assert(compare_coefficients == n_coefficients_per_direction,
+         ExcMessage("A different number of coefficients vector has been used "
+                    "to generate the transformation matrices you are about "
+                    "to load!"));
 
   // finite element collection
-  ar &size;
+  unsigned int size;
+  ar &         size;
   AssertDimension(size, fe_collection->size());
   std::string name;
   for (unsigned int i = 0; i < size; ++i)
@@ -675,4 +790,4 @@ FESeries::Legendre<dim, spacedim>::load_transformation_matrices(
 
 DEAL_II_NAMESPACE_CLOSE
 
-#endif // dealii_fe_series_H
+#endif // dealii_fe_series_h
index 746fea8972ca47835ad079945d1da6047308f65b..d7cdb068d99da4c0040d7f0c2e7c37fe83b47f26 100644 (file)
@@ -228,7 +228,8 @@ namespace hp
     n_blocks() const;
 
     /**
-     * Return the maximal degree over all elements of this collection.
+     * Return the maximum of values returned by FiniteElement::get_degree()
+     * over all elements of this collection.
      */
     unsigned int
     max_degree() const;
index cdb30ab7027bf5d77a5e00b97b25e0d4355bb018..659ad330492afd60d253b9c690b750fd57613105 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 
 #include <deal.II/base/config.h>
 
-#include <deal.II/dofs/dof_accessor.h>
-#include <deal.II/dofs/dof_handler.h>
-
-#include <deal.II/fe/fe_series.h>
-
-#include <deal.II/hp/dof_handler.h>
-
-#include <deal.II/lac/vector.h>
+#include <deal.II/fe/component_mask.h>
 
 #include <deal.II/numerics/vector_tools.h>
 
+#include <functional>
 #include <vector>
 
 
 DEAL_II_NAMESPACE_OPEN
 
 
+// forward declarations
+#ifndef DOXYGEN
+template <typename Number>
+class Vector;
+
+namespace FESeries
+{
+  template <int dim, int spacedim>
+  class Fourier;
+  template <int dim, int spacedim>
+  class Legendre;
+} // namespace FESeries
+
+namespace hp
+{
+  template <int dim, int spacedim>
+  class DoFHandler;
+  template <int dim, int spacedim>
+  class FECollection;
+} // namespace hp
+#endif
+
+
 /**
  * A namespace for various smoothness estimation strategies for hp-adaptive FEM.
+ *
+ * Smoothness estimation is one strategy to decide whether a cell with a large
+ * error estimate should undergo h- or p-refinement. Typical strategies decide
+ * to increase the polynomial degree on a cell if the solution is particularly
+ * smooth, whereas one would refine the mesh if the solution on the cell is
+ * singular, has kinks in some derivative, or is otherwise not particularly
+ * smooth. All of these strategies rely on a way to identify how "smooth" a
+ * function is on a given cell.
  */
 namespace SmoothnessEstimator
 {
   /**
-   * Estimate smoothness from decay of Legendre absolute values of coefficients
-   * on the reference cell.
+   * Smoothness estimation strategy based on the decay of Legendre expansion
+   * coefficients.
    *
-   * In one dimension, the finite element solution on the reference element with
-   * polynomial degree $p$ can be written as
+   * In one dimension, the finite element solution on cell $K$ with polynomial
+   * degree $p$ can be written as
+   * @f{eqnarray*}
+   *    u_h(x) &=& \sum_j u_j \varphi_j (x) \\
+   *    u_{h, k}(x) &=& \sum_{k=0}^{p} a_k \widetilde P_k (x),
+   *    \quad a_k = \sum_j {\cal L}_{k,j} u_j
+   * @f}
+   * where $u_j$ are degrees of freedom and $\varphi_j$ are the corresponding
+   * shape functions. $\{\widetilde P_k(x)\}$ are Legendre polynomials on cell
+   * $K$. $a_k$ and ${\cal L}_{k,j}$ are coefficients and transformation
+   * matrices from the Legendre expansion of each shape function. For practical
+   * reasons, we will perform the calculation of these matrices and coefficients
+   * only on the reference cell $\hat K$. We only have to calculate the
+   * transformation matrices once this way. However, results are only applicable
+   * if mapping from the reference cell to the actual cell is linear. We use
+   * the class FESeries::Legendre to determine all coefficients $a_k$.
+   *
+   * A function is analytic, i.e., representable by a power series, if and only
+   * if their Legendre expansion coefficients decay as (see @cite eibner2007hp)
    * @f[
-   *    u_h(\hat x) = \sum_{j=0}^{p} a_j P_j(\hat x)
+   *   |a_k| \sim c \, \exp(-\sigma k)
    * @f]
-   * where $\{P_j(x)\}$ are Legendre polynomials. The decay of the coefficients
-   * is estimated by performing the linear regression fit of
+   * We determine their decay rate $\sigma$ by performing the linear regression
+   * fit of
    * @f[
-   *   \ln |a_j| \sim C - \sigma j
+   *   \ln |a_k| \sim C - \sigma k
    * @f]
-   * for $j=0,..,p$. The rate of the decay $\sigma$ can be used to estimate the
-   * smoothness. For example, one strategy to implement hp-refinement
-   * criteria is to perform p-refinement if $\sigma>1$.
-   *
-   * Extension to higher dimension is done by performing the fit in each
-   * coordinate direction separately and then taking the lowest value of
-   * $\sigma$.
-   *
-   * For each input vector of degrees of freedom defined on a DoFHandler,
-   * this function returns a vector with as many elements as there are cells
-   * where each element contains $\exp(-\sigma)$, which is a so-called
-   * analyticity (see references below).
-   *
-   * @param [in] fe_series FESeries::Legendre object to calculate coefficients.
-   * This object needs to be initialized to have at least $p+1$ coefficients in
-   * each direction, where $p$ is the maximum polynomial degree to be used.
-   * @param [in] dof_hander An hp::DoFHandler
-   * @param [in] all_solutions A vector of pointers to the solution vectors
-   * @param [out] all_smoothness_indicators A vector of pointers to the smoothness indicators for each @p all_solutions.
-   * @param [in] coefficients_predicate A predicate to select Legendre
-   * coefficients $a_j \;\; j=0\dots p$ for linear regression in each coordinate
-   * direction. The user is responsible for updating the vector of `flags`
-   * provided to this function. Note that its size is $p+1$, where $p$ is the
-   * polynomial degree of the FE basis on a given element. Default
-   * implementation will use all Legendre coefficients in each coordinate
-   * direction, i.e. set all elements of the vector to `true`.
-   * @param [in] smallest_abs_coefficient The smallest absolute value of the
-   * coefficient to be used in linear regression in each coordinate direction.
-   * Note that Legendre coefficients of some functions may have a repeating
-   * pattern of zero coefficients (i.e. for functions that are locally symmetric
-   * or antisymmetric about the midpoint of the element in any coordinate
-   * direction). Thus this parameters allows to ingore small (in absolute value)
-   * coefficients within the linear regression fit. In case there are less than
-   * two non-zero coefficients for a coordinate direction, this direction will
-   * be skipped. If all coefficients are zero, the returned value for this cell
-   * will be zero (i.e. corresponding to the $\sigma=\infty$).
-   *
-   * For more theoretical details see
-   * @code{.bib}
-   * @Article{Mavriplis1994,
-   *  author    = {Mavriplis, Catherine},
-   *  title     = {Adaptive mesh strategies for the spectral element method},
-   *  journal   = {{Computer Methods in Applied Mechanics and Engineering}},
-   *  year      = {1994},
-   *  volume    = {116},
-   *  number    = {1},
-   *  pages     = {77--86},
-   *  publisher = {Elsevier},
-   * }
-   * @article{Houston2005,
-   *  author    = {Houston, Paul and S{\"u}li, Endre},
-   *  title     = {A note on the design of hp-adaptive finite element
-   *               methods for elliptic partial differential equations},
-   *  journal   = {{Computer Methods in Applied Mechanics and Engineering}},
-   *  number    = {2},
-   *  pages     = {229--243},
-   *  publisher = {Elsevier},
-   *  volume    = {194},
-   *  year      = {2005}
-   * }
-   * @article{Eibner2007,
-   *  author    = {Eibner, Tino and Melenk, Jens Markus},
-   *  title     = {An adaptive strategy for hp-FEM based on testing for
-   *               analyticity},
-   *  journal   = {{Computational Mechanics}},
-   *  year      = {2007},
-   *  volume    = {39},
-   *  number    = {5},
-   *  pages     = {575--595},
-   *  publisher = {Springer},
-   * }
-   * @endcode
-   * and for the application within the deal.II:
-   * @code{.bib}
-   * @article{Davydov2017,
-   *   author  = {Denis Davydov and Tymofiy Gerasimov and Jean-Paul Pelteret and
-   *              Paul Steinmann},
-   *   title   = {Convergence study of the h-adaptive PUM and the hp-adaptive
-   *              FEM applied to eigenvalue problems in quantum mechanics},
-   *   journal = {{Advanced Modeling and Simulation in Engineering Sciences}},
-   *   year    = {2017},
-   *   volume  = {4},
-   *   number  = {1},
-   *   pages   = {7},
-   *   issn    = {2213-7467},
-   *   doi     = {10.1186/s40323-017-0093-0},
-   * }
-   * @endcode
+   * for $k=0,\ldots,p$, with $p$ the polynomial degree of the finite element.
+   * The rate of the decay $\sigma$ can be used to estimate the smoothness. For
+   * example, one strategy to implement hp-refinement criteria is to perform
+   * p-refinement if $\sigma>1$ (see @cite mavriplis1994hp).
    *
-   * @ingroup numerics
-   * @author Denis Davydov, 2018
+   * @author Denis Davydov, 2018, Marc Fehling, 2018 - 2020
    */
-  template <int dim, int spacedim, typename VectorType>
-  void
-  legendre_coefficient_decay(
-    FESeries::Legendre<dim, spacedim> &    fe_series,
-    const hp::DoFHandler<dim, spacedim> &  dof_handler,
-    const std::vector<const VectorType *> &all_solutions,
-    const std::vector<Vector<float> *> &   all_smoothness_indicators,
-    const std::function<void(std::vector<bool> &flags)> coefficients_predicate =
-      [](std::vector<bool> &flags) -> void {
-      std::fill(flags.begin(), flags.end(), true);
-    },
-    const double smallest_abs_coefficient = 1e-10);
+  namespace Legendre
+  {
+    /**
+     * In this variant of the estimation strategy for higher dimensions, we will
+     * consider all mode vectors $\bf k$ describing Legendre polynomials
+     * $\widetilde P_{\bf k}$ and perform one least-squares fit over all
+     * coefficients at once. If there are multiple coefficients corresponding to
+     * the same absolute value of modes $\|{\bf k}\|_1$, we take the maximum
+     * among those. Thus, the least-squares fit is performed on
+     * @f{eqnarray*}
+     *   \widetilde P_{\bf k}({\bf x}) &=&
+     *     \widetilde P_{k_1} (x_1) \ldots \widetilde P_{k_d} (x_d) \\
+     *   \ln \left( \max\limits_{\|{\bf k}\|_1} |a_{\bf k}| \right) &\sim&
+     *     C - \sigma \|{\bf k}\|_1
+     * @f}
+     * for ${\bf k}=(k_1,\ldots,k_d)$ and $k_i=0,\ldots,p$, with $p$ the
+     * polynomial degree of the finite element.
+     *
+     * For a finite element approximation @p solution, this function writes the
+     * decay rate for every cell into the output vector @p smoothness_indicators.
+     *
+     * @param [in] fe_legendre FESeries::Legendre object to calculate coefficients.
+     * This object needs to be initialized to have at least $p+1$ coefficients
+     * in each direction for every finite element in the collection, where $p$
+     * is its polynomial degree.
+     * @param [in] dof_handler An hp::DoFHandler.
+     * @param [in] solution A solution vector.
+     * @param [out] smoothness_indicators A vector for smoothness indicators.
+     * @param [in] regression_strategy Determines which norm will be used on the
+     * subset of coefficients $\mathbf{k}$ with the same absolute value
+     * $\|{\bf k}\|_1$. Default is VectorTools::Linfty_norm for a maximum
+     * approximation.
+     * @param [in] smallest_abs_coefficient The smallest absolute value of the
+     * coefficient to be used in linear regression. Note that Legendre
+     * coefficients of some functions may have a repeating pattern of zero
+     * coefficients (i.e. for functions that are locally symmetric or
+     * antisymmetric about the midpoint of the element in any coordinate
+     * direction). Thus this parameters allows to ingore small (in absolute
+     * value) coefficients within the linear regression fit. In case there are
+     * less than two nonzero coefficients, the returned value for this cell will
+     * be $\sigma=\infty$.
+     * @param [in] only_flagged_cells Smoothness indicators are usually used to
+     * decide whether to perform h- or p-adaptation. So in most cases, we only
+     * need to calculate those indicators on cells flagged for refinement or
+     * coarsening. This parameter controls whether this particular subset or all
+     * cells will be considered. By default, all cells will be considered. When
+     * only flagged cells are supposed to be considered, smoothness indicators
+     * will only be set on those vector entries of flagged cells; the others
+     * will be set to a signaling NaN.
+     *
+     * For more theoretical details see @cite mavriplis1994hp
+     * @cite houston2005hp @cite eibner2007hp.
+     */
+    template <int dim, int spacedim, typename VectorType>
+    void
+    coefficient_decay(FESeries::Legendre<dim, spacedim> &  fe_legendre,
+                      const hp::DoFHandler<dim, spacedim> &dof_handler,
+                      const VectorType &                   solution,
+                      Vector<float> &             smoothness_indicators,
+                      const VectorTools::NormType regression_strategy =
+                        VectorTools::Linfty_norm,
+                      const double smallest_abs_coefficient = 1e-10,
+                      const bool   only_flagged_cells       = false);
+
+    /**
+     * In this variant of the estimation strategy for higher dimensions, we only
+     * consider modes in each coordinate direction, i.e., only mode vectors
+     * $\bf k$ with one nonzero entry. We perform the least-squares fit in
+     * each coordinate direction separately and take the lowest decay rate
+     * $\sigma$ among them.
+     *
+     * For a finite element approximation @p solution, this function writes the
+     * decay rate for every cell into the output vector @p smoothness_indicators.
+     *
+     * @param [in] fe_legendre FESeries::Legendre object to calculate coefficients.
+     * This object needs to be initialized to have at least $p+1$ coefficients
+     * in each direction, where $p$ is the maximum polynomial degree to be used.
+     * @param [in] dof_handler An hp::DoFHandler
+     * @param [in] solution A solution vector
+     * @param [out] smoothness_indicators A vector for smoothness indicators
+     * @param [in] coefficients_predicate A predicate to select Legendre
+     * coefficients $a_j$, $j=0,\ldots,p$ for linear regression in each
+     * coordinate direction. The user is responsible for updating the vector of
+     * `flags` provided to this function. Note that its size is $p+1$, where $p$
+     * is the polynomial degree of the FE basis on a given element. The default
+     * implementation will use all Legendre coefficients in each coordinate
+     * direction, i.e. set all elements of the vector to `true`.
+     * @param [in] smallest_abs_coefficient The smallest absolute value of the
+     * coefficient to be used in linear regression in each coordinate direction.
+     * Note that Legendre coefficients of some functions may have a repeating
+     * pattern of zero coefficients (i.e. for functions that are locally
+     * symmetric or antisymmetric about the midpoint of the element in any
+     * coordinate direction). Thus this parameters allows to ingore small (in
+     * absolute value) coefficients within the linear regression fit. In case
+     * there are less than two nonzero coefficients for a coordinate direction,
+     * this direction will be skipped. If all coefficients are zero, the
+     * returned value for this cell will be $\sigma=\infty$.
+     * @param [in] only_flagged_cells Smoothness indicators are usually used to
+     * decide whether to perform h- or p-adaptation. So in most cases, we only
+     * need to calculate those indicators on cells flagged for refinement or
+     * coarsening. This parameter controls whether this particular subset or all
+     * cells will be considered. By default, all cells will be considered. When
+     * only flagged cells are supposed to be considered, smoothness indicators
+     * will only be set on those vector entries of flagged cells; the others
+     * will be set to NaN.
+     *
+     * For more theoretical details and the application within the deal.II
+     * library see @cite davydov2017hp.
+     */
+    template <int dim, int spacedim, typename VectorType>
+    void
+    coefficient_decay_per_direction(
+      FESeries::Legendre<dim, spacedim> &  fe_legendre,
+      const hp::DoFHandler<dim, spacedim> &dof_handler,
+      const VectorType &                   solution,
+      Vector<float> &                      smoothness_indicators,
+      const ComponentMask &coefficients_predicate   = ComponentMask(),
+      const double         smallest_abs_coefficient = 1e-10,
+      const bool           only_flagged_cells       = false);
+
+    /**
+     * Number of modes for the default configuration of the Legendre series
+     * expansion FESeries::Legendre.
+     *
+     * We use as many modes as the highest polynomial of all finite elements
+     * used plus one, since we start with the first Legendre polynomial which is
+     * just a constant.
+     */
+    template <int dim, int spacedim>
+    std::vector<unsigned int>
+    default_number_of_coefficients_per_direction(
+      const hp::FECollection<dim, spacedim> &fe_collection);
+
+    /**
+     * Quadrature collection for the default configuration of the Legendre
+     * series expansion FESeries::Legendre.
+     *
+     * We use Gaussian quadrature designed to yield exact results for the
+     * highest order Legendre polynomial used.
+     */
+    template <int dim, int spacedim>
+    hp::QCollection<dim>
+    default_quadrature_collection(
+      const hp::FECollection<dim, spacedim> &fe_collection);
+  } // namespace Legendre
 
-  /**
-   * Same as above, but for a single solution vector.
-   */
-  template <int dim, int spacedim, typename VectorType>
-  void
-  legendre_coefficient_decay(
-    FESeries::Legendre<dim, spacedim> &                 fe_series,
-    const hp::DoFHandler<dim, spacedim> &               dof_handler,
-    const VectorType &                                  solution,
-    Vector<float> &                                     smoothness_indicators,
-    const std::function<void(std::vector<bool> &flags)> coefficients_predicate =
-      [](std::vector<bool> &flags) -> void {
-      std::fill(flags.begin(), flags.end(), true);
-    },
-    const double smallest_abs_coefficient = 1e-10);
 
-  /**
-   * Same as above, but for a single solution vector and with the default
-   * FESeries::Legendre.
-   */
-  template <int dim, int spacedim, typename VectorType>
-  void
-  legendre_coefficient_decay(
-    const hp::DoFHandler<dim, spacedim> &               dof_handler,
-    const VectorType &                                  solution,
-    Vector<float> &                                     smoothness_indicators,
-    const std::function<void(std::vector<bool> &flags)> coefficients_predicate =
-      [](std::vector<bool> &flags) -> void {
-      std::fill(flags.begin(), flags.end(), true);
-    },
-    const double smallest_abs_coefficient = 1e-10);
 
   /**
-   * Estimate the smoothness of a solution based on the decay of coefficients
-   * from a series expansion.
+   * Smoothness estimation strategy based on the decay of Fourier expansion
+   * coefficients.
    *
-   * From the definition, we can write our series expansion $\hat U_{\bf k}$ as
-   * a matrix product
+   * From the definition, we can write our Fourier series expansion
+   * $a_{\bf k}$ of the finite element solution on cell $K$ with polynomial
+   * degree $p$ as a matrix product
+   * @f{eqnarray*}
+   *    u_h({\bf x}) &=& \sum_j u_j \varphi_j ({\bf x}) \\
+   *    u_{h, {\bf k}}({\bf x}) &=&
+   *      \sum_{{\bf k}, \|{\bf k}\|\le p} a_{\bf k} \phi_{\bf k}({\bf x}),
+   *      \quad a_{\bf k} = \sum_j {\cal F}_{{\bf k},j} u_j
+   * @f}
+   * with $u_j$ the degrees of freedom and $\varphi_j$ the corresponding shape
+   * functions. $\{\phi_{\bf k}({\bf x}) = \exp(i \, 2 \pi \, {\bf k} \cdot
+   * {\bf x}) \}$ are expoential functions on cell $K$. $a_{\bf k}$ and ${\cal
+   * F}_{{\bf k},j}$ are coefficients and transformation matrices from the
+   * Fourier expansion of each shape function. For practical reasons, we will
+   * perform the calculation of these matrices and coefficients only on the
+   * reference cell $\hat K$. We only have to calculate the transformation
+   * matrices once this way. However, results are only applicable if mapping
+   * from the reference cell to the actual cell is linear. We use the class
+   * FESeries::Fourier to determine all coefficients $a_{\bf k}$.
+   *
+   * If the finite element approximation on cell $K$ is part of the Hilbert
+   * space $H^s(K)$, then the following integral must exit for both finite
+   * element and spectral representation of our solution
+   * @f{eqnarray*}
+   *   \| \nabla^s u_h({\bf x}) \|_{L^2(K)}^2 &=&
+   *     \int\limits_K \left| \nabla^s u_h({\bf x}) \right|^2 d{\bf x} <
+   *     \infty \\
+   *   \| \nabla^s u_{h, {\bf k}}({\bf x}) \|_{L^2(K)}^2 &=&
+   *     \int\limits_K \left| \sum\limits_{\bf k} (-i \, 2 \pi {\bf k})^s \,
+   *     a_{\bf k} \, \phi_{\bf k}({\bf x}) \right|^2 d{\bf x} =
+   *     (2 \pi)^{2s} \sum\limits_{\bf k} \left| a_{\bf k} \right|^2
+   *     \|{\bf k}\|_2^{2s} < \infty
+   * @f}
+   * The sum is finite only if the summands decay at least with order
    * @f[
-   *    \hat U_{\bf k}
-   *    = {\cal F}_{{\bf k},j} u_j,
+   *   |a_{\bf k}|^2 \|{\bf k}\|_2^{2s} \|{\bf k}\|_2^{d - 1} =
+   *     {\cal O}\left( \|{\bf k}\|_2^{-1-\epsilon} \right)
+   * @f]
+   * for all $\epsilon > 0$. The additional factor stems from the fact that,
+   * since we sum over all multi-indices ${\bf k}$ that are located on a
+   * dim-dimensional sphere, we actually have, up to a constant,
+   * $\|{\bf k}\|_2^{d-1}$ modes located in each increment $\|{\bf k}\|_2 +
+   * d\|{\bf k}\|_2$ that need to be taken into account. By a comparison of
+   * exponents, we can rewrite this condition as
+   * @f[
+   *   |a_{\bf k}| = {\cal O}\left(\|{\bf k}\|_2^
+   *     {-\left(s + \frac d2 + \epsilon \right)} \right)
    * @f]
-   * with $u_j$ the coefficients and ${\cal F}_{{\bf k},j}$ the transformation
-   * matrix from the expansion. We use the classes FESeries::Fourier and
-   * FESeries::Legendre to determine all coefficients $u_j$.
    *
    * The next step is that we have to estimate how fast these coefficients
-   * decay with $|{\bf k}|$. Thus, we perform a least-squares fit
+   * decay with $\|{\bf k}\|_2$. Thus, we perform a least-squares fit
    * @f[
-   *    \min_{\alpha,\mu}
-   *    \frac 12 \sum_{{\bf k}, |{\bf k}|\le N}
-   *    \left( |\hat U_{\bf k}| - \alpha |{\bf k}|^{-\mu}\right)^2
+   *    \min_{\alpha,\sigma}
+   *    \frac 12 \sum_{{\bf k}, \|{\bf k}\|_2 \le p}
+   *    \left( |a_{\bf k}| - \alpha \|{\bf k}\|_2^{-\sigma}\right)^2
    * @f]
-   * with linear regressions coefficients $\alpha$ and $\mu$. For
-   * simplification, we apply a logarithm on our minimization problem
+   * with regression coefficients $\alpha$ and $\sigma$. For simplification, we
+   * apply a logarithm on our minimization problem
    * @f[
-   *    \min_{\beta,\mu}
-   *    Q(\beta,\mu) =
-   *    \frac 12 \sum_{{\bf k}, |{\bf k}|\le N}
-   *    \left( \ln |\hat U_{\bf k}| - \beta + \mu \ln |{\bf k}|\right)^2,
+   *    \min_{\beta,\sigma}
+   *    Q(\beta,\sigma) =
+   *    \frac 12 \sum_{{\bf k}, \|{\bf k}\|_2 \le p}
+   *    \left( \ln |a_{\bf k}| - \beta + \sigma \ln \|{\bf k}\|_2
+   * \right)^2,
    * @f]
-   * where $\beta=\ln \alpha$. This is now a problem for which the
-   * optimality conditions $\frac{\partial Q}{\partial\beta}=0,
-   * \frac{\partial Q}{\partial\mu}=0$, are linear in $\beta,\mu$. We can
+   * where $\beta=\ln \alpha$. This is now a problem for which the optimality
+   * conditions $\frac{\partial Q}{\partial\beta}=0,
+   * \frac{\partial Q}{\partial\sigma}=0$, are linear in $\beta,\sigma$. We can
    * write these conditions as follows:
    * @f[
    *    \left(\begin{array}{cc}
-   *    \sum_{{\bf k}, |{\bf k}|\le N} 1 &
-   *    \sum_{{\bf k}, |{\bf k}|\le N} \ln |{\bf k}|
+   *    \sum_{{\bf k}, \|{\bf k}\|_2 \le p} 1 &
+   *    \sum_{{\bf k}, \|{\bf k}\|_2 \le p} \ln \|{\bf k}\|_2
    *    \\
-   *    \sum_{{\bf k}, |{\bf k}|\le N} \ln |{\bf k}| &
-   *    \sum_{{\bf k}, |{\bf k}|\le N} (\ln |{\bf k}|)^2
+   *    \sum_{{\bf k}, \|{\bf k}\|_2 \le p} \ln \|{\bf k}\|_2 &
+   *    \sum_{{\bf k}, \|{\bf k}\|_2 \le p} (\ln \|{\bf k}\|_2)^2
    *    \end{array}\right)
    *    \left(\begin{array}{c}
-   *    \beta \\ -\mu
+   *    \beta \\ -\sigma
    *    \end{array}\right)
    *    =
    *    \left(\begin{array}{c}
-   *    \sum_{{\bf k}, |{\bf k}|\le N} \ln |\hat U_{{\bf k}}|
+   *    \sum_{{\bf k}, \|{\bf k}\|_2\le p} \ln |a_{{\bf k}}|
    *    \\
-   *    \sum_{{\bf k}, |{\bf k}|\le N} \ln |\hat U_{{\bf k}}| \ln |{\bf k}|
-   *    \end{array}\right)
+   *    \sum_{{\bf k}, \|{\bf k}\|_2\le p} \ln |a_{{\bf k}}| \ln \|{\bf
+   * k}\|_2 \end{array}\right)
    * @f]
-   * Solving for $\beta$ and $\mu$ is nothing else but a linear regression fit
-   * and to do that we will use FESeries::linear_regression().
+   * Solving for $\beta$ and $\sigma$ is just a linear regression fit and to do
+   * that we will use FESeries::linear_regression().
    *
    * While we are not particularly interested in the actual value of
-   * $\beta$, the formula above gives us a mean to calculate the value of
-   * the exponent $\mu$ that we can then use to determine that
-   * $\hat u(\hat{\bf x})$ is in $H^s(\hat K)$ with $s=\mu-\frac d2$. These
-   * Sobolev indices $s$ will suffice as our smoothness estimators and will be
-   * calculated on each cell for any provided solution.
-   *
-   * @note An extensive demonstration of the use of these functions is provided in step-27.
-   *
-   * The @p regression_strategy parameter determines which norm will be used on the subset of
-   * coeffiecients $\mathbf{k}$ with the same absolute value $|\mathbf{k}|$.
-   * Default is VectorTools::Linfty_norm for a maximum approximation.
+   * $\beta$, the formula above gives us a means to calculate the value of
+   * the exponent $\sigma$ that we can then use to determine that
+   * $u(\hat{\bf x})$ is in $H^s(K)$ with $s=\sigma-\frac d2$. The
+   * decay rates $\sigma$ will suffice as our smoothness indicators and
+   * will be calculated on each cell for any provided solution.
    *
-   * Smoothness indicators will be calculated for each solution in @p all_solutions
-   * and stored in @p all_smoothness_indicators in the same order.
-   *
-   * An individual @p fe_series object can be supplied, which has to be constructed with the
-   * same FECollection object as the @p dof_handler.
-   *
-   * @ingroup numerics
-   * @author Denis Davydov, 2016, Marc Fehling, 2018
+   * @note An extensive demonstration of the use of these functions is
+   * provided in step-27.
    *
+   * @author Wolfgang Bangerth 2006 - 2007, Denis Davydov, 2016,
+   * Marc Fehling, 2018 - 2020
    */
-  template <int dim, int spacedim, typename VectorType>
-  void
-  fourier_coefficient_decay(
-    FESeries::Fourier<dim, spacedim> &     fe_series,
-    const hp::DoFHandler<dim, spacedim> &  dof_handler,
-    const std::vector<const VectorType *> &all_solutions,
-    const std::vector<Vector<float> *> &   all_smoothness_indicators,
-    const VectorTools::NormType regression_strategy = VectorTools::Linfty_norm);
+  namespace Fourier
+  {
+    /**
+     * In this variant of the estimation strategy for higher dimensions, we will
+     * consider all mode vectors $\bf k$ describing Fourier polynomials
+     * $P_{\bf k}$ and perform one least-squares fit over all coefficients
+     * at once. If there are multiple coefficients corresponding to the same
+     * absolute value of modes $\|\bf k\|_2$, we take the maximum among those.
+     * Thus, the least-squares fit is performed on
+     * @f[
+     *   \ln \left( \max\limits_{\|{\bf k}\|_2} |a_{\bf k}| \right) \sim
+     *     C - \sigma \ln \|{\bf k}\|_2
+     * @f]
+     * for ${\bf k}=(k_1,\ldots,k_d)$ and $k_i=0,\ldots,p$, with $p$ the
+     * polynomial degree of the finite element. We exclude the $\|{\bf k}\|_2=0$
+     * modes to avoid the singularity of the logarithm.
+     *
+     * The @p regression_strategy parameter determines which norm will be used
+     * on the subset of coefficients $\bf k$ with the same absolute value
+     * $\|{\bf k}\|_2$. Default is VectorTools::Linfty_norm for a maximum
+     * approximation.
+     *
+     * For a provided solution vector @p solution defined on a DoFHandler
+     * @p dof_handler, this function returns a vector @p smoothness_indicators
+     * with as many elements as there are cells where each element contains the
+     * estimated regularity $\sigma$.
+     *
+     * A series expansion object @p fe_fourier has to be supplied, which needs
+     * to be constructed with the same FECollection object as the @p dof_handler.
+     *
+     * The parameter @p smallest_abs_coefficient allows to ingore small (in
+     * absolute value) coefficients within the linear regression fit. In case
+     * there are less than two nonzero coefficients for a coordinate direction,
+     * this direction will be skipped. If all coefficients are zero, the
+     * returned value for this cell will be $\sigma=\infty$.
+     *
+     * Smoothness indicators are usually used to decide whether to perform h- or
+     * p-adaptation. So in most cases, we only need to calculate those
+     * indicators on cells flagged for refinement or coarsening. The parameter
+     * @p only_flagged_cells controls whether this particular subset or all
+     * cells will be considered. By default, all cells will be considered.
+     * When only flagged cells are supposed to be considered, smoothness
+     * indicators will only be set on those vector entries of flagged cells;
+     * the others will be set to a signaling NaN.
+     */
+    template <int dim, int spacedim, typename VectorType>
+    void
+    coefficient_decay(FESeries::Fourier<dim, spacedim> &   fe_fourier,
+                      const hp::DoFHandler<dim, spacedim> &dof_handler,
+                      const VectorType &                   solution,
+                      Vector<float> &             smoothness_indicators,
+                      const VectorTools::NormType regression_strategy =
+                        VectorTools::Linfty_norm,
+                      const double smallest_abs_coefficient = 1e-10,
+                      const bool   only_flagged_cells       = false);
 
-  /**
-   * Same as the function above, only for one @p solution vector.
-   */
-  template <int dim, int spacedim, typename VectorType>
-  void
-  fourier_coefficient_decay(
-    FESeries::Fourier<dim, spacedim> &   fe_series,
-    const hp::DoFHandler<dim, spacedim> &dof_handler,
-    const VectorType &                   solution,
-    Vector<float> &                      smoothness_indicators,
-    const VectorTools::NormType regression_strategy = VectorTools::Linfty_norm);
+    /**
+     * In this variant of the estimation strategy for higher dimensions, we only
+     * consider modes in each coordinate direction, i.e., only mode vectors
+     * $\bf k$ with one nonzero entry. We perform the least-squares fit in
+     * each coordinate direction separately and take the lowest decay rate
+     * $\sigma$ among them.
+     *
+     * The @p coefficients_predicate parameter selects Fourier coefficients
+     * $a_j$, $j=0,\ldots,p$ for linear regression in each coordinate
+     * direction. The user is responsible for updating the vector of `flags`
+     * provided to this function. Note that its size is $p+1$, where $p$ is the
+     * polynomial degree of the FE basis on a given element. The default
+     * implementation will use all Fourier coefficients in each coordinate
+     * direction, i.e. set all elements of the vector to `true`.
+     *
+     * For a provided solution vector @p solution defined on a DoFHandler
+     * @p dof_handler, this function returns a vector @p smoothness_indicators
+     * with as many elements as there are cells where each element contains the
+     * estimated regularity $\sigma$.
+     *
+     * A series expansion object @p fe_fourier has to be supplied, which needs
+     * to be constructed with the same FECollection object as the @p dof_handler.
+     *
+     * The parameter @p smallest_abs_coefficient allows to ingore small (in
+     * absolute value) coefficients within the linear regression fit. In case
+     * there are less than two nonzero coefficients for a coordinate direction,
+     * this direction will be skipped. If all coefficients are zero, the
+     * returned value for this cell will be $\sigma=\infty$.
+     *
+     * Smoothness indicators are usually used to decide whether to perform h- or
+     * p-adaptation. So in most cases, we only need to calculate those
+     * indicators on cells flagged for refinement or coarsening. The parameter
+     * @p only_flagged_cells controls whether this particular subset or all
+     * cells will be considered. By default, all cells will be considered.
+     * When only flagged cells are supposed to be considered, smoothness
+     * indicators will only be set on those vector entries of flagged cells;
+     * the others will be set to a signaling NaN.
+     */
+    template <int dim, int spacedim, typename VectorType>
+    void
+    coefficient_decay_per_direction(
+      FESeries::Fourier<dim, spacedim> &   fe_fourier,
+      const hp::DoFHandler<dim, spacedim> &dof_handler,
+      const VectorType &                   solution,
+      Vector<float> &                      smoothness_indicators,
+      const ComponentMask &coefficients_predicate   = ComponentMask(),
+      const double         smallest_abs_coefficient = 1e-10,
+      const bool           only_flagged_cells       = false);
 
-  /**
-   * Same as the function above, but with a default configuration for the chosen
-   * series expansion, using 2-point Gaussian quadrature for each finite
-   * element.
-   *
-   * Provide the desired series expansion as a template argument, i.e.
-   * @code
-   *    SmoothnessEstimator::estimate_by_coefficient_decay<FESeries::Fourier<dim>>(
-   *      dof_handler, all_solutions, all_smoothness_indicators);
-   * @endcode
-   */
-  template <int dim, int spacedim, typename VectorType>
-  void
-  fourier_coefficient_decay(
-    const hp::DoFHandler<dim, spacedim> &  dof_handler,
-    const std::vector<const VectorType *> &all_solutions,
-    const std::vector<Vector<float> *> &   all_smoothness_indicators,
-    const VectorTools::NormType regression_strategy = VectorTools::Linfty_norm);
+    /**
+     * Number of modes for the default configuration of the Fourier series
+     * expansion FESeries::Fourier.
+     *
+     * We use as many modes as the highest polynomial degree of all finite
+     * elements used plus one, and at least three modes.
+     */
+    template <int dim, int spacedim>
+    std::vector<unsigned int>
+    default_number_of_coefficients_per_direction(
+      const hp::FECollection<dim, spacedim> &fe_collection);
 
-  /**
-   * Same as the function above, only for one @p solution vector.
-   */
-  template <int dim, int spacedim, typename VectorType>
-  void
-  fourier_coefficient_decay(
-    const hp::DoFHandler<dim, spacedim> &dof_handler,
-    const VectorType &                   solution,
-    Vector<float> &                      smoothness_indicators,
-    const VectorTools::NormType regression_strategy = VectorTools::Linfty_norm);
+    /**
+     * Quadrature collection for the default configuration of the Fourier series
+     * expansion FESeries::Fourier.
+     *
+     * We use a 4-point Gaussian quarature iterated in each dimension by the
+     * maximal wave number, which is the number of modes decresed by one since
+     * we start with $k = 0$.
+     */
+    template <int dim, int spacedim>
+    hp::QCollection<dim>
+    default_quadrature_collection(
+      const hp::FECollection<dim, spacedim> &fe_collection);
+  } // namespace Fourier
 } // namespace SmoothnessEstimator
 
 
diff --git a/include/deal.II/numerics/smoothness_estimator.templates.h b/include/deal.II/numerics/smoothness_estimator.templates.h
deleted file mode 100644 (file)
index 48fb8d2..0000000
+++ /dev/null
@@ -1,450 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 1998 - 2018 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-#ifndef dealii_smoothness_estimator_templates_h
-#define dealii_smoothness_estimator_templates_h
-
-#include <deal.II/base/quadrature.h>
-
-#include <deal.II/fe/fe_series.h>
-
-#include <deal.II/hp/q_collection.h>
-
-#include <deal.II/numerics/smoothness_estimator.h>
-
-#include <algorithm>
-#include <cmath>
-#include <functional>
-#include <utility>
-
-
-DEAL_II_NAMESPACE_OPEN
-
-
-namespace SmoothnessEstimator
-{
-  namespace
-  {
-    /**
-     * Resizes @p coeff to @p N in each dimension.
-     */
-    template <int dim, typename CoefficientType>
-    void
-    resize(Table<dim, CoefficientType> &coeff, const unsigned int N)
-    {
-      TableIndices<dim> size;
-      for (unsigned int d = 0; d < dim; d++)
-        size[d] = N;
-      coeff.reinit(size);
-    }
-
-
-
-    /**
-     * we will need to take the maximum
-     * absolute value of fourier coefficients which correspond to $k$-vector
-     * $|{\bf k}|= const$. To filter the coefficients Table we
-     * will use the FESeries::process_coefficients() which requires a predicate
-     * to be specified. The predicate should operate on TableIndices and return
-     * a pair of <code>bool</code> and <code>unsigned int</code>. The latter
-     * is the value of the map from TableIndicies to unsigned int.  It is
-     * used to define subsets of coefficients from which we search for the one
-     * with highest absolute value, i.e. $l^\infty$-norm. The <code>bool</code>
-     * parameter defines which indices should be used in processing. In the
-     * current case we are interested in coefficients which correspond to
-     * $0 < i*i+j*j < N*N$ and $0 < i*i+j*j+k*k < N*N$ in 2D and 3D,
-     * respectively.
-     */
-    template <int dim>
-    std::pair<bool, unsigned int>
-    predicate(const TableIndices<dim> &ind, const unsigned int max_degree)
-    {
-      unsigned int v = 0;
-      for (unsigned int i = 0; i < dim; i++)
-        v += ind[i] * ind[i];
-      if (v > 0 && v < max_degree * max_degree)
-        return std::make_pair(true, v);
-      else
-        return std::make_pair(false, v);
-    }
-  } // namespace
-
-
-  template <int dim, int spacedim, typename VectorType>
-  void
-  legendre_coefficient_decay(
-    FESeries::Legendre<dim, spacedim> &    fe_legendre,
-    const hp::DoFHandler<dim, spacedim> &  dof_handler,
-    const std::vector<const VectorType *> &all_solutions,
-    const std::vector<Vector<float> *> &   all_smoothness_indicators,
-    const std::function<void(std::vector<bool> &flags)> coefficients_predicate,
-    const double smallest_abs_coefficient)
-  {
-    Assert(smallest_abs_coefficient >= 0.,
-           ExcMessage("smallest_abs_coefficient should be non-negative."));
-
-    using number = typename VectorType::value_type;
-    using number_coeff =
-      typename FESeries::Legendre<dim, spacedim>::CoefficientType;
-
-    AssertDimension(all_solutions.size(), all_smoothness_indicators.size());
-
-    for (auto &smoothness_indicator : all_smoothness_indicators)
-      smoothness_indicator->reinit(
-        dof_handler.get_triangulation().n_active_cells());
-
-    Table<dim, number_coeff> expansion_coefficients;
-    resize(expansion_coefficients, fe_legendre.get_size_in_each_direction());
-
-    Vector<number> local_dof_values;
-
-    // auxiliary vector to do linear regression
-    std::vector<number_coeff> x;
-    std::vector<number_coeff> y;
-
-    x.reserve(dof_handler.get_fe_collection().max_degree());
-    y.reserve(dof_handler.get_fe_collection().max_degree());
-
-    // precalculate predicates for each degree:
-    std::vector<std::vector<bool>> predicates(
-      dof_handler.get_fe_collection().max_degree());
-    for (unsigned int p = 1; p <= dof_handler.get_fe_collection().max_degree();
-         ++p)
-      {
-        auto &pred = predicates[p - 1];
-        // we have p+1 coefficients for degree p
-        pred.resize(p + 1);
-        coefficients_predicate(pred);
-      }
-
-    for (auto &cell : dof_handler.active_cell_iterators())
-      if (cell->is_locally_owned())
-        {
-          local_dof_values.reinit(cell->get_fe().dofs_per_cell);
-
-          const unsigned int pe = cell->get_fe().degree;
-
-          Assert(pe > 0, ExcInternalError());
-          const auto &pred = predicates[pe - 1];
-
-          // since we use coefficients with indices [1,pe] in each direction,
-          // the number of coefficients we need to calculate is at least N=pe+1
-          AssertIndexRange(pe, fe_legendre.get_size_in_each_direction());
-
-          auto solution_it              = all_solutions.cbegin();
-          auto smoothness_indicators_it = all_smoothness_indicators.begin();
-          for (; solution_it != all_solutions.cend();
-               ++solution_it, ++smoothness_indicators_it)
-            {
-              cell->get_dof_values(*(*solution_it), local_dof_values);
-              fe_legendre.calculate(local_dof_values,
-                                    cell->active_fe_index(),
-                                    expansion_coefficients);
-
-              // choose the smallest decay of coefficients in each direction,
-              // i.e. the maximum decay slope k_v
-              number_coeff k_v = -std::numeric_limits<number_coeff>::max();
-              for (unsigned int d = 0; d < dim; d++)
-                {
-                  x.resize(0);
-                  y.resize(0);
-
-                  // will use all non-zero coefficients allowed by the predicate
-                  // function
-                  Assert(pred.size() == pe + 1, ExcInternalError());
-                  for (unsigned int i = 0; i <= pe; i++)
-                    if (pred[i])
-                      {
-                        TableIndices<dim> ind;
-                        ind[d] = i;
-                        const number_coeff coeff_abs =
-                          std::abs(expansion_coefficients(ind));
-
-                        if (coeff_abs > smallest_abs_coefficient)
-                          {
-                            y.push_back(std::log(coeff_abs));
-                            x.push_back(i);
-                          }
-                      }
-
-                  // in case we don't have enough non-zero coefficient to fit,
-                  // skip this direction
-                  if (x.size() < 2)
-                    continue;
-
-                  const std::pair<number_coeff, number_coeff> fit =
-                    FESeries::linear_regression(x, y);
-
-                  // decay corresponds to negative slope
-                  // take the lesser negative slope along each direction
-                  k_v = std::max(k_v, fit.first);
-                }
-
-              (*(*smoothness_indicators_it))(cell->active_cell_index()) =
-                std::exp(k_v);
-            }
-        }
-  }
-
-
-
-  template <int dim, int spacedim, typename VectorType>
-  void
-  legendre_coefficient_decay(
-    FESeries::Legendre<dim, spacedim> &                 fe_legendre,
-    const hp::DoFHandler<dim, spacedim> &               dof_handler,
-    const VectorType &                                  solution,
-    Vector<float> &                                     smoothness_indicators,
-    const std::function<void(std::vector<bool> &flags)> coefficients_predicate,
-    const double smallest_abs_coefficient)
-  {
-    const std::vector<const VectorType *> all_solutions(1, &solution);
-    const std::vector<Vector<float> *>    all_smoothness_indicators(
-      1, &smoothness_indicators);
-
-    legendre_coefficient_decay(fe_legendre,
-                               dof_handler,
-                               all_solutions,
-                               all_smoothness_indicators,
-                               coefficients_predicate,
-                               smallest_abs_coefficient);
-  }
-
-
-
-  template <int dim, int spacedim, typename VectorType>
-  void
-  legendre_coefficient_decay(
-    const hp::DoFHandler<dim, spacedim> &               dof_handler,
-    const VectorType &                                  solution,
-    Vector<float> &                                     smoothness_indicators,
-    const std::function<void(std::vector<bool> &flags)> coefficients_predicate,
-    const double smallest_abs_coefficient)
-  {
-    const unsigned int max_degree =
-      dof_handler.get_fe_collection().max_degree();
-
-    // We initialize a FESeries::Legendre expansion object object which will be
-    // used to calculate the expansion coefficients. In addition to the
-    // hp::FECollection, we need to provide quadrature rules hp::QCollection for
-    // integration on the reference cell.
-    // We will need to assemble the expansion matrices for each of the finite
-    // elements we deal with, i.e. the matrices F_k,j. We have to do that for
-    // each of the finite elements in use. To that end we need a quadrature
-    // rule. As a default, we use the same quadrature formula for each finite
-    // element, namely one that is obtained by iterating a 2-point Gauss formula
-    // as many times as the maximal polynomial degree.
-    QGauss<1>      base_quadrature(2);
-    QIterated<dim> quadrature(base_quadrature, max_degree);
-
-    hp::QCollection<dim> expansion_q_collection;
-    for (unsigned int i = 0; i < dof_handler.get_fe_collection().size(); ++i)
-      expansion_q_collection.push_back(quadrature);
-
-    FESeries::Legendre<dim, spacedim> legendre(max_degree + 1,
-                                               dof_handler.get_fe_collection(),
-                                               expansion_q_collection);
-
-    legendre_coefficient_decay(legendre,
-                               dof_handler,
-                               solution,
-                               smoothness_indicators,
-                               coefficients_predicate,
-                               smallest_abs_coefficient);
-  }
-
-
-
-  template <int dim, int spacedim, typename VectorType>
-  void
-  fourier_coefficient_decay(
-    FESeries::Fourier<dim, spacedim> &     fe_series,
-    const hp::DoFHandler<dim, spacedim> &  dof_handler,
-    const std::vector<const VectorType *> &all_solutions,
-    const std::vector<Vector<float> *> &   all_smoothness_indicators,
-    const VectorTools::NormType            regression_strategy)
-  {
-    using number = typename VectorType::value_type;
-    using number_coeff =
-      typename FESeries::Fourier<dim, spacedim>::CoefficientType;
-
-    AssertDimension(all_solutions.size(), all_smoothness_indicators.size());
-
-    for (auto &smoothness_indicator : all_smoothness_indicators)
-      smoothness_indicator->reinit(
-        dof_handler.get_triangulation().n_active_cells());
-
-    const unsigned int max_degree =
-      dof_handler.get_fe_collection().max_degree();
-
-    Table<dim, number_coeff> expansion_coefficients;
-    resize(expansion_coefficients, max_degree);
-
-    Vector<number>                                            local_dof_values;
-    std::vector<double>                                       ln_k;
-    std::pair<std::vector<unsigned int>, std::vector<double>> res;
-    for (auto &cell : dof_handler.active_cell_iterators())
-      if (cell->is_locally_owned())
-        {
-          local_dof_values.reinit(cell->get_fe().dofs_per_cell);
-
-          auto solution_it              = all_solutions.cbegin();
-          auto smoothness_indicators_it = all_smoothness_indicators.begin();
-          for (; solution_it != all_solutions.cend();
-               ++solution_it, ++smoothness_indicators_it)
-            {
-              // Inside the loop, we first need to get the values of the local
-              // degrees of freedom and then need to compute the series
-              // expansion by multiplying this vector with the matrix ${\cal F}$
-              // corresponding to this finite element.
-              cell->get_dof_values(*(*solution_it), local_dof_values);
-
-              fe_series.calculate(local_dof_values,
-                                  cell->active_fe_index(),
-                                  expansion_coefficients);
-
-              // We fit our exponential decay of expansion coefficients to the
-              // provided regression_strategy on each possible value of |k|. To
-              // this end, we use FESeries::process_coefficients() to rework
-              // coefficients into the desired format.
-              res = FESeries::process_coefficients<dim>(
-                expansion_coefficients,
-                std::bind(&predicate<dim>, std::placeholders::_1, max_degree),
-                regression_strategy);
-
-              Assert(res.first.size() == res.second.size(), ExcInternalError());
-
-              // Prepare linear equation for the logarithmic least squares fit.
-              //
-              // First, calculate ln(|k|). This vector will be the same for all
-              // the cells so we can calculate ln(|k|) only once.
-              //
-              // For Fourier expansion, this translates to
-              // ln(2*pi*sqrt(predicate)) = ln(2*pi) + 0.5*ln(predicate). Since
-              // we are just interested in a linear regression later, we omit
-              // the ln(2*pi) factor.
-              // For Legendre expansion, this translates to
-              // 0.5*ln(predicate) as well, without the pi factor.
-              if (ln_k.empty())
-                {
-                  ln_k.resize(res.first.size());
-                  for (unsigned int f = 0; f < res.first.size(); ++f)
-                    ln_k[f] = 0.5 * std::log((double)res.first[f]);
-                }
-
-              // Second, calculate ln(U_k).
-              for (auto &residual_element : res.second)
-                residual_element = std::log(residual_element);
-
-              // Last, do the linear regression.
-              const auto fit = FESeries::linear_regression(ln_k, res.second);
-
-              // Compute the Sobolev index s=mu-dim/2 and store it in the vector
-              // of estimated values for each cell.
-              (*(*smoothness_indicators_it))(cell->active_cell_index()) =
-                (float)(-fit.first - .5 * dim);
-            }
-        }
-  }
-
-
-
-  template <int dim, int spacedim, typename VectorType>
-  void
-  fourier_coefficient_decay(FESeries::Fourier<dim, spacedim> &   fe_series,
-                            const hp::DoFHandler<dim, spacedim> &dof_handler,
-                            const VectorType &                   solution,
-                            Vector<float> &             smoothness_indicators,
-                            const VectorTools::NormType regression_strategy)
-  {
-    const std::vector<const VectorType *> all_solutions(1, &solution);
-    const std::vector<Vector<float> *>    all_smoothness_indicators(
-      1, &smoothness_indicators);
-
-    fourier_coefficient_decay(fe_series,
-                              dof_handler,
-                              all_solutions,
-                              all_smoothness_indicators,
-                              regression_strategy);
-  }
-
-
-
-  template <int dim, int spacedim, typename VectorType>
-  void
-  fourier_coefficient_decay(
-    const hp::DoFHandler<dim, spacedim> &  dof_handler,
-    const std::vector<const VectorType *> &all_solutions,
-    const std::vector<Vector<float> *> &   all_smoothness_indicators,
-    const VectorTools::NormType            regression_strategy)
-  {
-    const unsigned int max_degree =
-      dof_handler.get_fe_collection().max_degree();
-
-    // We initialize a series expansion object object which will be used to
-    // calculate the expansion coefficients. In addition to the
-    // hp::FECollection, we need to provide quadrature rules hp::QCollection for
-    // integration on the reference cell.
-    // We will need to assemble the expansion matrices for each of the finite
-    // elements we deal with, i.e. the matrices F_k,j. We have to do that for
-    // each of the finite elements in use. To that end we need a quadrature
-    // rule. As a default, we use the same quadrature formula for each finite
-    // element, namely one that is obtained by iterating a 2-point Gauss formula
-    // as many times as the maximal exponent we use for the term exp(ikx).
-    QGauss<1>      base_quadrature(2);
-    QIterated<dim> quadrature(base_quadrature, max_degree);
-
-    hp::QCollection<dim> expansion_q_collection;
-    for (unsigned int i = 0; i < dof_handler.get_fe_collection().size(); ++i)
-      expansion_q_collection.push_back(quadrature);
-
-    // The FESeries::Fourier class' constructor first parameter $N$ defines the
-    // number of coefficients in 1D with the total number of coefficients being
-    // $N^{dim}$.
-    FESeries::Fourier<dim, spacedim> fe_series(max_degree,
-                                               dof_handler.get_fe_collection(),
-                                               expansion_q_collection);
-
-    fourier_coefficient_decay(fe_series,
-                              dof_handler,
-                              all_solutions,
-                              all_smoothness_indicators,
-                              regression_strategy);
-  }
-
-
-
-  template <int dim, int spacedim, typename VectorType>
-  void
-  fourier_coefficient_decay(const hp::DoFHandler<dim, spacedim> &dof_handler,
-                            const VectorType &                   solution,
-                            Vector<float> &             smoothness_indicators,
-                            const VectorTools::NormType regression_strategy)
-  {
-    const std::vector<const VectorType *> all_solutions(1, &solution);
-    const std::vector<Vector<float> *>    all_smoothness_indicators(
-      1, &smoothness_indicators);
-
-    fourier_coefficient_decay(dof_handler,
-                              all_solutions,
-                              all_smoothness_indicators,
-                              regression_strategy);
-  }
-} // namespace SmoothnessEstimator
-
-
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
index 923f59234ec7d2fa692041beb341f211b72a64df..e810baa426de9bd27d354526ad8d36c21060f799 100644 (file)
@@ -86,6 +86,7 @@ namespace
   template <int spacedim>
   void
   ensure_existence(
+    const std::vector<unsigned int> &              n_coefficients_per_direction,
     const hp::FECollection<1, spacedim> &          fe_collection,
     const hp::QCollection<1> &                     q_collection,
     const Table<1, Tensor<1, 1>> &                 k_vectors,
@@ -96,10 +97,10 @@ namespace
 
     if (fourier_transform_matrices[fe].m() == 0)
       {
-        fourier_transform_matrices[fe].reinit(k_vectors.n_elements(),
+        fourier_transform_matrices[fe].reinit(n_coefficients_per_direction[fe],
                                               fe_collection[fe].dofs_per_cell);
 
-        for (unsigned int k = 0; k < k_vectors.size(0); ++k)
+        for (unsigned int k = 0; k < n_coefficients_per_direction[fe]; ++k)
           for (unsigned int j = 0; j < fe_collection[fe].dofs_per_cell; ++j)
             fourier_transform_matrices[fe](k, j) =
               integrate(fe_collection[fe], q_collection[fe], k_vectors(k), j);
@@ -109,6 +110,7 @@ namespace
   template <int spacedim>
   void
   ensure_existence(
+    const std::vector<unsigned int> &              n_coefficients_per_direction,
     const hp::FECollection<2, spacedim> &          fe_collection,
     const hp::QCollection<2> &                     q_collection,
     const Table<2, Tensor<1, 2>> &                 k_vectors,
@@ -119,12 +121,14 @@ namespace
 
     if (fourier_transform_matrices[fe].m() == 0)
       {
-        fourier_transform_matrices[fe].reinit(k_vectors.n_elements(),
-                                              fe_collection[fe].dofs_per_cell);
+        fourier_transform_matrices[fe].reinit(
+          Utilities::fixed_power<2>(n_coefficients_per_direction[fe]),
+          fe_collection[fe].dofs_per_cell);
 
         unsigned int k = 0;
-        for (unsigned int k1 = 0; k1 < k_vectors.size(0); ++k1)
-          for (unsigned int k2 = 0; k2 < k_vectors.size(1); ++k2, k++)
+        for (unsigned int k1 = 0; k1 < n_coefficients_per_direction[fe]; ++k1)
+          for (unsigned int k2 = 0; k2 < n_coefficients_per_direction[fe];
+               ++k2, ++k)
             for (unsigned int j = 0; j < fe_collection[fe].dofs_per_cell; ++j)
               fourier_transform_matrices[fe](k, j) = integrate(
                 fe_collection[fe], q_collection[fe], k_vectors(k1, k2), j);
@@ -134,6 +138,7 @@ namespace
   template <int spacedim>
   void
   ensure_existence(
+    const std::vector<unsigned int> &              n_coefficients_per_direction,
     const hp::FECollection<3, spacedim> &          fe_collection,
     const hp::QCollection<3> &                     q_collection,
     const Table<3, Tensor<1, 3>> &                 k_vectors,
@@ -144,13 +149,15 @@ namespace
 
     if (fourier_transform_matrices[fe].m() == 0)
       {
-        fourier_transform_matrices[fe].reinit(k_vectors.n_elements(),
-                                              fe_collection[fe].dofs_per_cell);
+        fourier_transform_matrices[fe].reinit(
+          Utilities::fixed_power<3>(n_coefficients_per_direction[fe]),
+          fe_collection[fe].dofs_per_cell);
 
         unsigned int k = 0;
-        for (unsigned int k1 = 0; k1 < k_vectors.size(0); ++k1)
-          for (unsigned int k2 = 0; k2 < k_vectors.size(1); ++k2)
-            for (unsigned int k3 = 0; k3 < k_vectors.size(2); ++k3, k++)
+        for (unsigned int k1 = 0; k1 < n_coefficients_per_direction[fe]; ++k1)
+          for (unsigned int k2 = 0; k2 < n_coefficients_per_direction[fe]; ++k2)
+            for (unsigned int k3 = 0; k3 < n_coefficients_per_direction[fe];
+                 ++k3, ++k)
               for (unsigned int j = 0; j < fe_collection[fe].dofs_per_cell; ++j)
                 fourier_transform_matrices[fe](k, j) =
                   integrate(fe_collection[fe],
@@ -167,28 +174,54 @@ namespace FESeries
 {
   template <int dim, int spacedim>
   Fourier<dim, spacedim>::Fourier(
-    const unsigned int                     N,
+    const std::vector<unsigned int> &      n_coefficients_per_direction,
     const hp::FECollection<dim, spacedim> &fe_collection,
     const hp::QCollection<dim> &           q_collection)
-    : fe_collection(&fe_collection)
+    : n_coefficients_per_direction(n_coefficients_per_direction)
+    , fe_collection(&fe_collection)
     , q_collection(&q_collection)
     , fourier_transform_matrices(fe_collection.size())
   {
-    set_k_vectors(k_vectors, N);
-    unrolled_coefficients.resize(k_vectors.n_elements());
+    Assert(n_coefficients_per_direction.size() == fe_collection.size() &&
+             n_coefficients_per_direction.size() == q_collection.size(),
+           ExcMessage("All parameters are supposed to have the same size."));
+
+    const unsigned int max_n_coefficients_per_direction =
+      *std::max_element(n_coefficients_per_direction.cbegin(),
+                        n_coefficients_per_direction.cend());
+    set_k_vectors(k_vectors, max_n_coefficients_per_direction);
+
+    // reserve sufficient memory
+    unrolled_coefficients.reserve(k_vectors.n_elements());
   }
 
 
 
+  template <int dim, int spacedim>
+  Fourier<dim, spacedim>::Fourier(
+    const unsigned int                     n_coefficients_per_direction,
+    const hp::FECollection<dim, spacedim> &fe_collection,
+    const hp::QCollection<dim> &           q_collection)
+    : Fourier<dim, spacedim>(
+        std::vector<unsigned int>(fe_collection.size(),
+                                  n_coefficients_per_direction),
+        fe_collection,
+        q_collection)
+  {}
+
+
+
   template <int dim, int spacedim>
   inline bool
   Fourier<dim, spacedim>::
   operator==(const Fourier<dim, spacedim> &fourier) const
   {
-    return ((*fe_collection == *(fourier.fe_collection)) &&
-            (*q_collection == *(fourier.q_collection)) &&
-            (k_vectors == fourier.k_vectors) &&
-            (fourier_transform_matrices == fourier.fourier_transform_matrices));
+    return (
+      (n_coefficients_per_direction == fourier.n_coefficients_per_direction) &&
+      (*fe_collection == *(fourier.fe_collection)) &&
+      (*q_collection == *(fourier.q_collection)) &&
+      (k_vectors == fourier.k_vectors) &&
+      (fourier_transform_matrices == fourier.fourier_transform_matrices));
   }
 
 
@@ -200,7 +233,8 @@ namespace FESeries
     Threads::TaskGroup<> task_group;
     for (unsigned int fe = 0; fe < fe_collection->size(); ++fe)
       task_group += Threads::new_task([&, fe]() {
-        ensure_existence(*fe_collection,
+        ensure_existence(n_coefficients_per_direction,
+                         *fe_collection,
                          *q_collection,
                          k_vectors,
                          fe,
@@ -212,6 +246,51 @@ namespace FESeries
 
 
 
+  template <int dim, int spacedim>
+  void
+  Fourier<dim, spacedim>::initialize(
+    const std::vector<unsigned int> &      n_coefficients_per_direction,
+    const hp::FECollection<dim, spacedim> &fe_collection,
+    const hp::QCollection<dim> &           q_collection)
+  {
+    Assert(n_coefficients_per_direction.size() == fe_collection.size() &&
+             n_coefficients_per_direction.size() == q_collection.size(),
+           ExcMessage("All parameters are supposed to have the same size."));
+
+    // set members
+    this->n_coefficients_per_direction = n_coefficients_per_direction;
+    this->fe_collection =
+      SmartPointer<const hp::FECollection<dim, spacedim>>(&fe_collection);
+    this->q_collection =
+      SmartPointer<const hp::QCollection<dim>>(&q_collection);
+
+    // clean up auxiliary members
+    k_vectors.reset_values();
+    const unsigned int max_n_coefficients_per_direction =
+      *std::max_element(n_coefficients_per_direction.cbegin(),
+                        n_coefficients_per_direction.cend());
+    set_k_vectors(k_vectors, max_n_coefficients_per_direction);
+
+    fourier_transform_matrices.clear();
+    fourier_transform_matrices.resize(fe_collection.size());
+
+    unrolled_coefficients.clear();
+    // reserve sufficient memory
+    unrolled_coefficients.reserve(k_vectors.n_elements());
+  }
+
+
+
+  template <int dim, int spacedim>
+  unsigned int
+  Fourier<dim, spacedim>::get_n_coefficients_per_direction(
+    const unsigned int index) const
+  {
+    return n_coefficients_per_direction[index];
+  }
+
+
+
   template <int dim, int spacedim>
   template <typename Number>
   void
@@ -220,7 +299,14 @@ namespace FESeries
     const unsigned int           cell_active_fe_index,
     Table<dim, CoefficientType> &fourier_coefficients)
   {
-    ensure_existence(*fe_collection,
+    Assert(fe_collection != nullptr && q_collection != nullptr,
+           ExcMessage("Initialize this FESeries object first!"));
+    for (unsigned int d = 0; d < dim; ++d)
+      AssertDimension(fourier_coefficients.size(d),
+                      n_coefficients_per_direction[cell_active_fe_index]);
+
+    ensure_existence(n_coefficients_per_direction,
+                     *fe_collection,
                      *q_collection,
                      k_vectors,
                      cell_active_fe_index,
@@ -229,6 +315,8 @@ namespace FESeries
     const FullMatrix<CoefficientType> &matrix =
       fourier_transform_matrices[cell_active_fe_index];
 
+    unrolled_coefficients.resize(Utilities::fixed_power<dim>(
+      n_coefficients_per_direction[cell_active_fe_index]));
     std::fill(unrolled_coefficients.begin(),
               unrolled_coefficients.end(),
               CoefficientType(0.));
index b23de8ad085bbfbc35a27f33a72a2d835dc49e82..6be7a8a4f0e239f06c13d25d0e0be807e6511fce 100644 (file)
@@ -107,20 +107,21 @@ namespace
    */
   template <int spacedim>
   void
-  ensure_existence(const hp::FECollection<1, spacedim> &fe_collection,
-                   const hp::QCollection<1> &           q_collection,
-                   const unsigned int                   N,
-                   const unsigned int                   fe,
-                   std::vector<FullMatrix<double>> &legendre_transform_matrices)
+  ensure_existence(
+    const std::vector<unsigned int> &    n_coefficients_per_direction,
+    const hp::FECollection<1, spacedim> &fe_collection,
+    const hp::QCollection<1> &           q_collection,
+    const unsigned int                   fe,
+    std::vector<FullMatrix<double>> &    legendre_transform_matrices)
   {
     AssertIndexRange(fe, fe_collection.size());
 
     if (legendre_transform_matrices[fe].m() == 0)
       {
-        legendre_transform_matrices[fe].reinit(N,
+        legendre_transform_matrices[fe].reinit(n_coefficients_per_direction[fe],
                                                fe_collection[fe].dofs_per_cell);
 
-        for (unsigned int k = 0; k < N; ++k)
+        for (unsigned int k = 0; k < n_coefficients_per_direction[fe]; ++k)
           for (unsigned int j = 0; j < fe_collection[fe].dofs_per_cell; ++j)
             legendre_transform_matrices[fe](k, j) = integrate(
               fe_collection[fe], q_collection[fe], TableIndices<1>(k), j);
@@ -129,22 +130,25 @@ namespace
 
   template <int spacedim>
   void
-  ensure_existence(const hp::FECollection<2, spacedim> &fe_collection,
-                   const hp::QCollection<2> &           q_collection,
-                   const unsigned int                   N,
-                   const unsigned int                   fe,
-                   std::vector<FullMatrix<double>> &legendre_transform_matrices)
+  ensure_existence(
+    const std::vector<unsigned int> &    n_coefficients_per_direction,
+    const hp::FECollection<2, spacedim> &fe_collection,
+    const hp::QCollection<2> &           q_collection,
+    const unsigned int                   fe,
+    std::vector<FullMatrix<double>> &    legendre_transform_matrices)
   {
     AssertIndexRange(fe, fe_collection.size());
 
     if (legendre_transform_matrices[fe].m() == 0)
       {
-        legendre_transform_matrices[fe].reinit(N * N,
-                                               fe_collection[fe].dofs_per_cell);
+        legendre_transform_matrices[fe].reinit(
+          Utilities::fixed_power<2>(n_coefficients_per_direction[fe]),
+          fe_collection[fe].dofs_per_cell);
 
         unsigned int k = 0;
-        for (unsigned int k1 = 0; k1 < N; ++k1)
-          for (unsigned int k2 = 0; k2 < N; ++k2, k++)
+        for (unsigned int k1 = 0; k1 < n_coefficients_per_direction[fe]; ++k1)
+          for (unsigned int k2 = 0; k2 < n_coefficients_per_direction[fe];
+               ++k2, k++)
             for (unsigned int j = 0; j < fe_collection[fe].dofs_per_cell; ++j)
               legendre_transform_matrices[fe](k, j) =
                 integrate(fe_collection[fe],
@@ -156,23 +160,26 @@ namespace
 
   template <int spacedim>
   void
-  ensure_existence(const hp::FECollection<3, spacedim> &fe_collection,
-                   const hp::QCollection<3> &           q_collection,
-                   const unsigned int                   N,
-                   const unsigned int                   fe,
-                   std::vector<FullMatrix<double>> &legendre_transform_matrices)
+  ensure_existence(
+    const std::vector<unsigned int> &    n_coefficients_per_direction,
+    const hp::FECollection<3, spacedim> &fe_collection,
+    const hp::QCollection<3> &           q_collection,
+    const unsigned int                   fe,
+    std::vector<FullMatrix<double>> &    legendre_transform_matrices)
   {
     AssertIndexRange(fe, fe_collection.size());
 
     if (legendre_transform_matrices[fe].m() == 0)
       {
-        legendre_transform_matrices[fe].reinit(N * N * N,
-                                               fe_collection[fe].dofs_per_cell);
+        legendre_transform_matrices[fe].reinit(
+          Utilities::fixed_power<3>(n_coefficients_per_direction[fe]),
+          fe_collection[fe].dofs_per_cell);
 
         unsigned int k = 0;
-        for (unsigned int k1 = 0; k1 < N; ++k1)
-          for (unsigned int k2 = 0; k2 < N; ++k2)
-            for (unsigned int k3 = 0; k3 < N; ++k3, k++)
+        for (unsigned int k1 = 0; k1 < n_coefficients_per_direction[fe]; ++k1)
+          for (unsigned int k2 = 0; k2 < n_coefficients_per_direction[fe]; ++k2)
+            for (unsigned int k3 = 0; k3 < n_coefficients_per_direction[fe];
+                 ++k3, k++)
               for (unsigned int j = 0; j < fe_collection[fe].dofs_per_cell; ++j)
                 legendre_transform_matrices[fe](k, j) =
                   integrate(fe_collection[fe],
@@ -189,14 +196,38 @@ namespace FESeries
 {
   template <int dim, int spacedim>
   Legendre<dim, spacedim>::Legendre(
-    const unsigned int                     size_in_each_direction,
+    const std::vector<unsigned int> &      n_coefficients_per_direction,
     const hp::FECollection<dim, spacedim> &fe_collection,
     const hp::QCollection<dim> &           q_collection)
-    : N(size_in_each_direction)
+    : n_coefficients_per_direction(n_coefficients_per_direction)
     , fe_collection(&fe_collection)
     , q_collection(&q_collection)
     , legendre_transform_matrices(fe_collection.size())
-    , unrolled_coefficients(Utilities::fixed_power<dim>(N), 0.)
+  {
+    Assert(n_coefficients_per_direction.size() == fe_collection.size() &&
+             n_coefficients_per_direction.size() == q_collection.size(),
+           ExcMessage("All parameters are supposed to have the same size."));
+
+    // reserve sufficient memory
+    const unsigned int max_n_coefficients_per_direction =
+      *std::max_element(n_coefficients_per_direction.cbegin(),
+                        n_coefficients_per_direction.cend());
+    unrolled_coefficients.reserve(
+      Utilities::fixed_power<dim>(max_n_coefficients_per_direction));
+  }
+
+
+
+  template <int dim, int spacedim>
+  Legendre<dim, spacedim>::Legendre(
+    const unsigned int                     n_coefficients_per_direction,
+    const hp::FECollection<dim, spacedim> &fe_collection,
+    const hp::QCollection<dim> &           q_collection)
+    : Legendre<dim, spacedim>(
+        std::vector<unsigned int>(fe_collection.size(),
+                                  n_coefficients_per_direction),
+        fe_collection,
+        q_collection)
   {}
 
 
@@ -207,7 +238,8 @@ namespace FESeries
   operator==(const Legendre<dim, spacedim> &legendre) const
   {
     return (
-      (N == legendre.N) && (*fe_collection == *(legendre.fe_collection)) &&
+      (n_coefficients_per_direction == legendre.n_coefficients_per_direction) &&
+      (*fe_collection == *(legendre.fe_collection)) &&
       (*q_collection == *(legendre.q_collection)) &&
       (legendre_transform_matrices == legendre.legendre_transform_matrices));
   }
@@ -221,8 +253,11 @@ namespace FESeries
     Threads::TaskGroup<> task_group;
     for (unsigned int fe = 0; fe < fe_collection->size(); ++fe)
       task_group += Threads::new_task([&, fe]() {
-        ensure_existence(
-          *fe_collection, *q_collection, N, fe, legendre_transform_matrices);
+        ensure_existence(n_coefficients_per_direction,
+                         *fe_collection,
+                         *q_collection,
+                         fe,
+                         legendre_transform_matrices);
       });
 
     task_group.join_all();
@@ -230,11 +265,45 @@ namespace FESeries
 
 
 
+  template <int dim, int spacedim>
+  void
+  Legendre<dim, spacedim>::initialize(
+    const std::vector<unsigned int> &      n_coefficients_per_direction,
+    const hp::FECollection<dim, spacedim> &fe_collection,
+    const hp::QCollection<dim> &           q_collection)
+  {
+    Assert(n_coefficients_per_direction.size() == fe_collection.size() &&
+             n_coefficients_per_direction.size() == q_collection.size(),
+           ExcMessage("All parameters are supposed to have the same size."));
+
+    // set members
+    this->n_coefficients_per_direction = n_coefficients_per_direction;
+    this->fe_collection =
+      SmartPointer<const hp::FECollection<dim, spacedim>>(&fe_collection);
+    this->q_collection =
+      SmartPointer<const hp::QCollection<dim>>(&q_collection);
+
+    // clean up auxiliary members
+    legendre_transform_matrices.clear();
+    legendre_transform_matrices.resize(fe_collection.size());
+
+    unrolled_coefficients.clear();
+    // reserve sufficient memory
+    const unsigned int max_n_coefficients_per_direction =
+      *std::max_element(n_coefficients_per_direction.cbegin(),
+                        n_coefficients_per_direction.cend());
+    unrolled_coefficients.reserve(
+      Utilities::fixed_power<dim>(max_n_coefficients_per_direction));
+  }
+
+
+
   template <int dim, int spacedim>
   unsigned int
-  Legendre<dim, spacedim>::get_size_in_each_direction() const
+  Legendre<dim, spacedim>::get_n_coefficients_per_direction(
+    const unsigned int index) const
   {
-    return N;
+    return n_coefficients_per_direction[index];
   }
 
 
@@ -247,18 +316,23 @@ namespace FESeries
     const unsigned int            cell_active_fe_index,
     Table<dim, CoefficientType> & legendre_coefficients)
   {
+    Assert(fe_collection != nullptr && q_collection != nullptr,
+           ExcMessage("Initialize this FESeries object first!"));
     for (unsigned int d = 0; d < dim; ++d)
-      AssertDimension(legendre_coefficients.size(d), N);
+      AssertDimension(legendre_coefficients.size(d),
+                      n_coefficients_per_direction[cell_active_fe_index]);
 
-    ensure_existence(*fe_collection,
+    ensure_existence(n_coefficients_per_direction,
+                     *fe_collection,
                      *q_collection,
-                     N,
                      cell_active_fe_index,
                      legendre_transform_matrices);
 
     const FullMatrix<CoefficientType> &matrix =
       legendre_transform_matrices[cell_active_fe_index];
 
+    unrolled_coefficients.resize(Utilities::fixed_power<dim>(
+      n_coefficients_per_direction[cell_active_fe_index]));
     std::fill(unrolled_coefficients.begin(),
               unrolled_coefficients.end(),
               CoefficientType(0.));
index f47d71f4d3c493dbb1165a60aa7d0f414eddd783..eca416709a90557e59249e61573f127eb58b8f24 100644 (file)
@@ -137,13 +137,9 @@ namespace hp
              dealii::GridRefinement::ExcInvalidParameterValue());
 
       // We first have to determine the maximal and minimal values of the
-      // criteria of all flagged cells. We start with the minimal and maximal
-      // values of all cells, a range within which the minimal and maximal
-      // values on cells flagged for refinement must surely lie.
-      Number max_criterion_refine =
-               *std::min_element(criteria.begin(), criteria.end()),
-             min_criterion_refine =
-               *std::max_element(criteria.begin(), criteria.end());
+      // criteria of all flagged cells.
+      Number max_criterion_refine  = std::numeric_limits<Number>::lowest(),
+             min_criterion_refine  = std::numeric_limits<Number>::max();
       Number max_criterion_coarsen = max_criterion_refine,
              min_criterion_coarsen = min_criterion_refine;
 
index 028dab93e728f7e3da2605666480561b51f55f4e..7ae55dc1ba9db03f2cbe7841b5f754a2c58420ba 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8276f8aa85eed0cdf47853d536ff2ef9784c7df5..568765d245c8d32dd34afb3e7a27d61992ba83d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
+#include <deal.II/base/quadrature.h>
+#include <deal.II/base/signaling_nan.h>
+
+#include <deal.II/fe/fe_series.h>
+
+#include <deal.II/hp/dof_handler.h>
+#include <deal.II/hp/q_collection.h>
+
 #include <deal.II/lac/block_vector.h>
 #include <deal.II/lac/la_parallel_block_vector.h>
 #include <deal.II/lac/la_parallel_vector.h>
 #include <deal.II/lac/trilinos_vector.h>
 #include <deal.II/lac/vector.h>
 
-#include <deal.II/numerics/smoothness_estimator.templates.h>
+#include <deal.II/numerics/smoothness_estimator.h>
+
+#include <algorithm>
+#include <cmath>
+#include <limits>
+#include <utility>
+
 
 DEAL_II_NAMESPACE_OPEN
 
+
+namespace SmoothnessEstimator
+{
+  namespace
+  {
+    /**
+     * Resizes @p coeff to @p N in each dimension.
+     */
+    template <int dim, typename CoefficientType>
+    void
+    resize(Table<dim, CoefficientType> &coeff, const unsigned int N)
+    {
+      TableIndices<dim> size;
+      for (unsigned int d = 0; d < dim; d++)
+        size[d] = N;
+      coeff.reinit(size);
+    }
+  } // namespace
+
+
+
+  namespace Legendre
+  {
+    namespace
+    {
+      /**
+       * We will need to take the maximum absolute value of Legendre
+       * coefficients which correspond to $k$-vector $|{\bf k}|= const$. To
+       * filter the coefficients Table we will use the
+       * FESeries::process_coefficients() which requires a predicate to be
+       * specified. The predicate should operate on TableIndices and return a
+       * pair of <code>bool</code> and <code>unsigned int</code>. The latter is
+       * the value of the map from TableIndicies to unsigned int.  It is used to
+       * define subsets of coefficients from which we search for the one with
+       * highest absolute value, i.e. $l^\infty$-norm. The <code>bool</code>
+       * parameter defines which indices should be used in processing. In the
+       * current case we are interested in coefficients which correspond to $0
+       * <= i+j < N$ and $0 <= i+j+k < N$ in 2D and 3D, respectively.
+       */
+      template <int dim>
+      std::pair<bool, unsigned int>
+      index_sum_less_than_N(const TableIndices<dim> &ind, const unsigned int N)
+      {
+        unsigned int v = 0;
+        for (unsigned int i = 0; i < dim; ++i)
+          v += ind[i];
+
+        return std::make_pair((v < N), v);
+      }
+    } // namespace
+
+
+
+    template <int dim, int spacedim, typename VectorType>
+    void
+    coefficient_decay(FESeries::Legendre<dim, spacedim> &  fe_legendre,
+                      const hp::DoFHandler<dim, spacedim> &dof_handler,
+                      const VectorType &                   solution,
+                      Vector<float> &             smoothness_indicators,
+                      const VectorTools::NormType regression_strategy,
+                      const double                smallest_abs_coefficient,
+                      const bool                  only_flagged_cells)
+    {
+      using number = typename VectorType::value_type;
+      using number_coeff =
+        typename FESeries::Legendre<dim, spacedim>::CoefficientType;
+
+      smoothness_indicators.reinit(
+        dof_handler.get_triangulation().n_active_cells());
+
+      unsigned int             n_modes;
+      Table<dim, number_coeff> expansion_coefficients;
+
+      Vector<number>      local_dof_values;
+      std::vector<double> converted_indices;
+      std::pair<std::vector<unsigned int>, std::vector<double>> res;
+      for (const auto &cell : dof_handler.active_cell_iterators())
+        if (cell->is_locally_owned())
+          {
+            if (!only_flagged_cells || cell->refine_flag_set() ||
+                cell->coarsen_flag_set())
+              {
+                n_modes = fe_legendre.get_n_coefficients_per_direction(
+                  cell->active_fe_index());
+                resize(expansion_coefficients, n_modes);
+
+                local_dof_values.reinit(cell->get_fe().dofs_per_cell);
+                cell->get_dof_values(solution, local_dof_values);
+
+                fe_legendre.calculate(local_dof_values,
+                                      cell->active_fe_index(),
+                                      expansion_coefficients);
+
+                // We fit our exponential decay of expansion coefficients to the
+                // provided regression_strategy on each possible value of |k|.
+                // To this end, we use FESeries::process_coefficients() to
+                // rework coefficients into the desired format.
+                res = FESeries::process_coefficients<dim>(
+                  expansion_coefficients,
+                  [n_modes](const TableIndices<dim> &indices) {
+                    return index_sum_less_than_N(indices, n_modes);
+                  },
+                  regression_strategy,
+                  smallest_abs_coefficient);
+
+                Assert(res.first.size() == res.second.size(),
+                       ExcInternalError());
+
+                // Last, do the linear regression.
+                float regularity = std::numeric_limits<float>::infinity();
+                if (res.first.size() > 1)
+                  {
+                    // Prepare linear equation for the logarithmic least squares
+                    // fit.
+                    converted_indices.assign(res.first.begin(),
+                                             res.first.end());
+
+                    for (auto &residual_element : res.second)
+                      residual_element = std::log(residual_element);
+
+                    const std::pair<double, double> fit =
+                      FESeries::linear_regression(converted_indices,
+                                                  res.second);
+                    regularity = static_cast<float>(-fit.first);
+                  }
+
+                smoothness_indicators(cell->active_cell_index()) = regularity;
+              }
+            else
+              smoothness_indicators(cell->active_cell_index()) =
+                numbers::signaling_nan<float>();
+          }
+    }
+
+
+
+    template <int dim, int spacedim, typename VectorType>
+    void
+    coefficient_decay_per_direction(
+      FESeries::Legendre<dim, spacedim> &  fe_legendre,
+      const hp::DoFHandler<dim, spacedim> &dof_handler,
+      const VectorType &                   solution,
+      Vector<float> &                      smoothness_indicators,
+      const ComponentMask &                coefficients_predicate,
+      const double                         smallest_abs_coefficient,
+      const bool                           only_flagged_cells)
+    {
+      Assert(smallest_abs_coefficient >= 0.,
+             ExcMessage("smallest_abs_coefficient should be non-negative."));
+
+      using number = typename VectorType::value_type;
+      using number_coeff =
+        typename FESeries::Legendre<dim, spacedim>::CoefficientType;
+
+      smoothness_indicators.reinit(
+        dof_handler.get_triangulation().n_active_cells());
+
+      unsigned int             n_modes;
+      Table<dim, number_coeff> expansion_coefficients;
+      Vector<number>           local_dof_values;
+
+      // auxiliary vector to do linear regression
+      const unsigned int max_degree =
+        dof_handler.get_fe_collection().max_degree();
+
+      std::vector<double> x, y;
+      x.reserve(max_degree);
+      y.reserve(max_degree);
+
+      for (const auto &cell : dof_handler.active_cell_iterators())
+        if (cell->is_locally_owned())
+          {
+            if (!only_flagged_cells || cell->refine_flag_set() ||
+                cell->coarsen_flag_set())
+              {
+                n_modes = fe_legendre.get_n_coefficients_per_direction(
+                  cell->active_fe_index());
+                resize(expansion_coefficients, n_modes);
+
+                const unsigned int pe = cell->get_fe().degree;
+                Assert(pe > 0, ExcInternalError());
+
+                // since we use coefficients with indices [1,pe] in each
+                // direction, the number of coefficients we need to calculate is
+                // at least N=pe+1
+                AssertIndexRange(pe, n_modes);
+
+                local_dof_values.reinit(cell->get_fe().dofs_per_cell);
+                cell->get_dof_values(solution, local_dof_values);
+
+                fe_legendre.calculate(local_dof_values,
+                                      cell->active_fe_index(),
+                                      expansion_coefficients);
+
+                // choose the smallest decay of coefficients in each direction,
+                // i.e. the maximum decay slope k_v as in exp(-k_v)
+                double k_v = std::numeric_limits<double>::infinity();
+                for (unsigned int d = 0; d < dim; ++d)
+                  {
+                    x.resize(0);
+                    y.resize(0);
+
+                    // will use all non-zero coefficients allowed by the
+                    // predicate function
+                    for (unsigned int i = 0; i <= pe; ++i)
+                      if (coefficients_predicate[i])
+                        {
+                          TableIndices<dim> ind;
+                          ind[d] = i;
+                          const double coeff_abs =
+                            std::abs(expansion_coefficients(ind));
+
+                          if (coeff_abs > smallest_abs_coefficient)
+                            {
+                              x.push_back(i);
+                              y.push_back(std::log(coeff_abs));
+                            }
+                        }
+
+                    // in case we don't have enough non-zero coefficient to fit,
+                    // skip this direction
+                    if (x.size() < 2)
+                      continue;
+
+                    const std::pair<double, double> fit =
+                      FESeries::linear_regression(x, y);
+
+                    // decay corresponds to negative slope
+                    // take the lesser negative slope along each direction
+                    k_v = std::min(k_v, -fit.first);
+                  }
+
+                smoothness_indicators(cell->active_cell_index()) =
+                  static_cast<float>(k_v);
+              }
+            else
+              smoothness_indicators(cell->active_cell_index()) =
+                numbers::signaling_nan<float>();
+          }
+    }
+
+
+
+    template <int dim, int spacedim>
+    std::vector<unsigned int>
+    default_number_of_coefficients_per_direction(
+      const hp::FECollection<dim, spacedim> &fe_collection)
+    {
+      std::vector<unsigned int> n_coefficients_per_direction;
+      for (unsigned int i = 0; i < fe_collection.size(); ++i)
+        n_coefficients_per_direction.push_back(fe_collection[i].degree + 1);
+
+      return n_coefficients_per_direction;
+    }
+
+
+
+    template <int dim, int spacedim>
+    hp::QCollection<dim>
+    default_quadrature_collection(
+      const hp::FECollection<dim, spacedim> &fe_collection)
+    {
+      const std::vector<unsigned int> n_modes =
+        default_number_of_coefficients_per_direction(fe_collection);
+
+      // We initialize a FESeries::Legendre expansion object object which will
+      // be used to calculate the expansion coefficients. In addition to the
+      // hp::FECollection, we need to provide quadrature rules hp::QCollection
+      // for integration on the reference cell.
+      // We will need to assemble the expansion matrices for each of the finite
+      // elements we deal with, i.e. the matrices F_k,j. We have to do that for
+      // each of the finite elements in use. To that end we need a quadrature
+      // rule. As a default, we use the same quadrature formula for each finite
+      // element, namely a Gauss formula that yields exact results for the
+      // highest order Legendre polynomial used.
+
+      // We start with the zeroth Legendre polynomial which is just a constant,
+      // so the highest Legendre polynomial will be of order (n_modes - 1).
+      hp::QCollection<dim> q_collection;
+      for (unsigned int i = 0; i < fe_collection.size(); ++i)
+        {
+          const QGauss<dim>  quadrature(n_modes[i]);
+          const QSorted<dim> quadrature_sorted(quadrature);
+          q_collection.push_back(quadrature_sorted);
+        }
+
+      return q_collection;
+    }
+  } // namespace Legendre
+
+
+
+  namespace Fourier
+  {
+    namespace
+    {
+      /**
+       * We will need to take the maximum absolute value of Fourier coefficients
+       * which correspond to $k$-vector $|{\bf k}|= const$. To filter the
+       * coefficients Table we will use the FESeries::process_coefficients()
+       * which requires a predicate to be specified. The predicate should
+       * operate on TableIndices and return a pair of <code>bool</code> and
+       * <code>unsigned int</code>. The latter is the value of the map from
+       * TableIndicies to unsigned int.  It is used to define subsets of
+       * coefficients from which we search for the one with highest absolute
+       * value, i.e. $l^\infty$-norm. The <code>bool</code> parameter defines
+       * which indices should be used in processing. In the current case we are
+       * interested in coefficients which correspond to $0 < i^2+j^2 < N^2$ and
+       * $0 < i^2+j^2+k^2 < N^2$ in 2D and 3D, respectively.
+       */
+      template <int dim>
+      std::pair<bool, unsigned int>
+      index_norm_greater_than_zero_and_less_than_N_squared(
+        const TableIndices<dim> &ind,
+        const unsigned int       N)
+      {
+        unsigned int v = 0;
+        for (unsigned int i = 0; i < dim; ++i)
+          v += ind[i] * ind[i];
+
+        return std::make_pair((v > 0 && v < N * N), v);
+      }
+    } // namespace
+
+
+
+    template <int dim, int spacedim, typename VectorType>
+    void
+    coefficient_decay(FESeries::Fourier<dim, spacedim> &   fe_fourier,
+                      const hp::DoFHandler<dim, spacedim> &dof_handler,
+                      const VectorType &                   solution,
+                      Vector<float> &             smoothness_indicators,
+                      const VectorTools::NormType regression_strategy,
+                      const double                smallest_abs_coefficient,
+                      const bool                  only_flagged_cells)
+    {
+      using number = typename VectorType::value_type;
+      using number_coeff =
+        typename FESeries::Fourier<dim, spacedim>::CoefficientType;
+
+      smoothness_indicators.reinit(
+        dof_handler.get_triangulation().n_active_cells());
+
+      unsigned int             n_modes;
+      Table<dim, number_coeff> expansion_coefficients;
+
+      Vector<number>      local_dof_values;
+      std::vector<double> ln_k;
+      std::pair<std::vector<unsigned int>, std::vector<double>> res;
+      for (const auto &cell : dof_handler.active_cell_iterators())
+        if (cell->is_locally_owned())
+          {
+            if (!only_flagged_cells || cell->refine_flag_set() ||
+                cell->coarsen_flag_set())
+              {
+                n_modes = fe_fourier.get_n_coefficients_per_direction(
+                  cell->active_fe_index());
+                resize(expansion_coefficients, n_modes);
+
+                // Inside the loop, we first need to get the values of the local
+                // degrees of freedom and then need to compute the series
+                // expansion by multiplying this vector with the matrix ${\cal
+                // F}$ corresponding to this finite element.
+                local_dof_values.reinit(cell->get_fe().dofs_per_cell);
+                cell->get_dof_values(solution, local_dof_values);
+
+                fe_fourier.calculate(local_dof_values,
+                                     cell->active_fe_index(),
+                                     expansion_coefficients);
+
+                // We fit our exponential decay of expansion coefficients to the
+                // provided regression_strategy on each possible value of |k|.
+                // To this end, we use FESeries::process_coefficients() to
+                // rework coefficients into the desired format.
+                res = FESeries::process_coefficients<dim>(
+                  expansion_coefficients,
+                  [n_modes](const TableIndices<dim> &indices) {
+                    return index_norm_greater_than_zero_and_less_than_N_squared(
+                      indices, n_modes);
+                  },
+                  regression_strategy,
+                  smallest_abs_coefficient);
+
+                Assert(res.first.size() == res.second.size(),
+                       ExcInternalError());
+
+                // Last, do the linear regression.
+                float regularity = std::numeric_limits<float>::infinity();
+                if (res.first.size() > 1)
+                  {
+                    // Prepare linear equation for the logarithmic least squares
+                    // fit.
+                    //
+                    // First, calculate ln(|k|).
+                    //
+                    // For Fourier expansion, this translates to
+                    // ln(2*pi*sqrt(predicate)) = ln(2*pi) + 0.5*ln(predicate).
+                    // Since we are just interested in the slope of a linear
+                    // regression later, we omit the ln(2*pi) factor.
+                    ln_k.resize(res.first.size());
+                    for (unsigned int f = 0; f < res.first.size(); ++f)
+                      ln_k[f] =
+                        0.5 * std::log(static_cast<double>(res.first[f]));
+
+                    // Second, calculate ln(U_k).
+                    for (auto &residual_element : res.second)
+                      residual_element = std::log(residual_element);
+
+                    const std::pair<double, double> fit =
+                      FESeries::linear_regression(ln_k, res.second);
+                    // Compute regularity s = mu - dim/2
+                    regularity = static_cast<float>(-fit.first) -
+                                 ((dim > 1) ? (.5 * dim) : 0);
+                  }
+
+                // Store result in the vector of estimated values for each cell.
+                smoothness_indicators(cell->active_cell_index()) = regularity;
+              }
+            else
+              smoothness_indicators(cell->active_cell_index()) =
+                numbers::signaling_nan<float>();
+          }
+    }
+
+
+
+    template <int dim, int spacedim, typename VectorType>
+    void
+    coefficient_decay_per_direction(
+      FESeries::Fourier<dim, spacedim> &   fe_fourier,
+      const hp::DoFHandler<dim, spacedim> &dof_handler,
+      const VectorType &                   solution,
+      Vector<float> &                      smoothness_indicators,
+      const ComponentMask &                coefficients_predicate,
+      const double                         smallest_abs_coefficient,
+      const bool                           only_flagged_cells)
+    {
+      Assert(smallest_abs_coefficient >= 0.,
+             ExcMessage("smallest_abs_coefficient should be non-negative."));
+
+      using number = typename VectorType::value_type;
+      using number_coeff =
+        typename FESeries::Fourier<dim, spacedim>::CoefficientType;
+
+      smoothness_indicators.reinit(
+        dof_handler.get_triangulation().n_active_cells());
+
+      unsigned int             n_modes;
+      Table<dim, number_coeff> expansion_coefficients;
+      Vector<number>           local_dof_values;
+
+      // auxiliary vector to do linear regression
+      const unsigned int max_degree =
+        dof_handler.get_fe_collection().max_degree();
+
+      std::vector<double> x, y;
+      x.reserve(max_degree);
+      y.reserve(max_degree);
+
+      for (const auto &cell : dof_handler.active_cell_iterators())
+        if (cell->is_locally_owned())
+          {
+            if (!only_flagged_cells || cell->refine_flag_set() ||
+                cell->coarsen_flag_set())
+              {
+                n_modes = fe_fourier.get_n_coefficients_per_direction(
+                  cell->active_fe_index());
+                resize(expansion_coefficients, n_modes);
+
+                const unsigned int pe = cell->get_fe().degree;
+                Assert(pe > 0, ExcInternalError());
+
+                // since we use coefficients with indices [1,pe] in each
+                // direction, the number of coefficients we need to calculate is
+                // at least N=pe+1
+                AssertIndexRange(pe, n_modes);
+
+                local_dof_values.reinit(cell->get_fe().dofs_per_cell);
+                cell->get_dof_values(solution, local_dof_values);
+
+                fe_fourier.calculate(local_dof_values,
+                                     cell->active_fe_index(),
+                                     expansion_coefficients);
+
+                // choose the smallest decay of coefficients in each direction,
+                // i.e. the maximum decay slope k_v as in exp(-k_v)
+                double k_v = std::numeric_limits<double>::infinity();
+                for (unsigned int d = 0; d < dim; ++d)
+                  {
+                    x.resize(0);
+                    y.resize(0);
+
+                    // will use all non-zero coefficients allowed by the
+                    // predicate function
+                    //
+                    // skip i=0 because of logarithm
+                    for (unsigned int i = 1; i <= pe; ++i)
+                      if (coefficients_predicate[i])
+                        {
+                          TableIndices<dim> ind;
+                          ind[d] = i;
+                          const double coeff_abs =
+                            std::abs(expansion_coefficients(ind));
+
+                          if (coeff_abs > smallest_abs_coefficient)
+                            {
+                              x.push_back(std::log(i));
+                              y.push_back(std::log(coeff_abs));
+                            }
+                        }
+
+                    // in case we don't have enough non-zero coefficient to fit,
+                    // skip this direction
+                    if (x.size() < 2)
+                      continue;
+
+                    const std::pair<double, double> fit =
+                      FESeries::linear_regression(x, y);
+
+                    // decay corresponds to negative slope
+                    // take the lesser negative slope along each direction
+                    k_v = std::min(k_v, -fit.first);
+                  }
+
+                smoothness_indicators(cell->active_cell_index()) =
+                  static_cast<float>(k_v);
+              }
+            else
+              smoothness_indicators(cell->active_cell_index()) =
+                numbers::signaling_nan<float>();
+          }
+    }
+
+
+
+    template <int dim, int spacedim>
+    std::vector<unsigned int>
+    default_number_of_coefficients_per_direction(
+      const hp::FECollection<dim, spacedim> &fe_collection)
+    {
+      std::vector<unsigned int> n_coefficients_per_direction;
+      for (unsigned int i = 0; i < fe_collection.size(); ++i)
+        n_coefficients_per_direction.push_back(
+          std::max<unsigned int>(3, fe_collection[i].degree + 1));
+
+      return n_coefficients_per_direction;
+    }
+
+
+
+    template <int dim, int spacedim>
+    hp::QCollection<dim>
+    default_quadrature_collection(
+      const hp::FECollection<dim, spacedim> &fe_collection)
+    {
+      const std::vector<unsigned int> n_modes =
+        default_number_of_coefficients_per_direction(fe_collection);
+
+      // We initialize a series expansion object object which will be used to
+      // calculate the expansion coefficients. In addition to the
+      // hp::FECollection, we need to provide quadrature rules hp::QCollection
+      // for integration on the reference cell.
+      // We will need to assemble the expansion matrices for each of the finite
+      // elements we deal with, i.e. the matrices F_k,j. We have to do that for
+      // each of the finite elements in use. To that end we need a quadrature
+      // rule. As a default, we use the same quadrature formula for each finite
+      // element, namely one that is obtained by iterating a 4-point Gauss
+      // formula as many times as the maximal exponent we use for the term
+      // exp(ikx). Since the first mode corresponds to k = 0, the maximal wave
+      // number is k = n_modes - 1.
+      const QGauss<1>      base_quadrature(4);
+      hp::QCollection<dim> q_collection;
+      for (unsigned int i = 0; i < fe_collection.size(); ++i)
+        {
+          const QIterated<dim> quadrature(base_quadrature, n_modes[i] - 1);
+          const QSorted<dim>   quadrature_sorted(quadrature);
+          q_collection.push_back(quadrature_sorted);
+        }
+
+      return q_collection;
+    }
+  } // namespace Fourier
+} // namespace SmoothnessEstimator
+
+
+// explicit instantiations
 #include "smoothness_estimator.inst"
 
 DEAL_II_NAMESPACE_CLOSE
index d6aca7def7c891e556da5374557e132117a7901e..912fa2d70c3c09b554708a5fb144442afce9adfc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
      VEC : REAL_VECTOR_TYPES)
   {
-#if deal_II_dimension != 1 && deal_II_dimension <= deal_II_space_dimension
-    template void SmoothnessEstimator::legendre_coefficient_decay<
+#if deal_II_dimension <= deal_II_space_dimension
+    template void SmoothnessEstimator::Legendre::
+      coefficient_decay<deal_II_dimension, deal_II_space_dimension, VEC>(
+        FESeries::Legendre<deal_II_dimension, deal_II_space_dimension> &,
+        const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
+        const VEC &,
+        Vector<float> &,
+        const VectorTools::NormType,
+        const double,
+        const bool);
+    template void
+    SmoothnessEstimator::Legendre::coefficient_decay_per_direction<
       deal_II_dimension,
       deal_II_space_dimension,
       VEC>(FESeries::Legendre<deal_II_dimension, deal_II_space_dimension> &,
            const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
-           const std::vector<const VEC *> &,
-           const std::vector<Vector<float> *> &,
-           const std::function<void(std::vector<bool> & flags)>,
-           const double);
-
-    template void SmoothnessEstimator::legendre_coefficient_decay<
-      deal_II_dimension,
-      deal_II_space_dimension,
-      VEC>(FESeries::Legendre<deal_II_dimension, deal_II_space_dimension> &,
-           const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
-           const VEC &,
-           Vector<float> &,
-           const std::function<void(std::vector<bool> & flags)>,
-           const double);
-
-    template void SmoothnessEstimator::legendre_coefficient_decay<
-      deal_II_dimension,
-      deal_II_space_dimension,
-      VEC>(const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
            const VEC &,
            Vector<float> &,
-           const std::function<void(std::vector<bool> & flags)>,
-           const double);
+           const ComponentMask &,
+           const double,
+           const bool);
 
-    template void SmoothnessEstimator::fourier_coefficient_decay<
-      deal_II_dimension,
-      deal_II_space_dimension,
-      VEC>(FESeries::Fourier<deal_II_dimension, deal_II_space_dimension> &,
-           const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
-           const std::vector<const VEC *> &,
-           const std::vector<Vector<float> *> &,
-           const VectorTools::NormType);
-    template void SmoothnessEstimator::fourier_coefficient_decay<
+    template void SmoothnessEstimator::Fourier::
+      coefficient_decay<deal_II_dimension, deal_II_space_dimension, VEC>(
+        FESeries::Fourier<deal_II_dimension, deal_II_space_dimension> &,
+        const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
+        const VEC &,
+        Vector<float> &,
+        const VectorTools::NormType,
+        const double,
+        const bool);
+    template void SmoothnessEstimator::Fourier::coefficient_decay_per_direction<
       deal_II_dimension,
       deal_II_space_dimension,
       VEC>(FESeries::Fourier<deal_II_dimension, deal_II_space_dimension> &,
            const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
            const VEC &,
            Vector<float> &,
-           const VectorTools::NormType);
+           const ComponentMask &,
+           const double,
+           const bool);
+#endif
+  }
 
-    template void SmoothnessEstimator::fourier_coefficient_decay<
-      deal_II_dimension,
-      deal_II_space_dimension,
-      VEC>(const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
-           const std::vector<const VEC *> &,
-           const std::vector<Vector<float> *> &,
-           const VectorTools::NormType);
-    template void SmoothnessEstimator::fourier_coefficient_decay<
-      deal_II_dimension,
-      deal_II_space_dimension,
-      VEC>(const hp::DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
-           const VEC &,
-           Vector<float> &,
-           const VectorTools::NormType);
+for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
+  {
+#if deal_II_dimension <= deal_II_space_dimension
+    template std::vector<unsigned int> SmoothnessEstimator::Legendre::
+      default_number_of_coefficients_per_direction<deal_II_dimension,
+                                                   deal_II_space_dimension>(
+        const hp::FECollection<deal_II_dimension, deal_II_space_dimension> &);
+    template hp::QCollection<deal_II_dimension> SmoothnessEstimator::Legendre::
+      default_quadrature_collection<deal_II_dimension, deal_II_space_dimension>(
+        const hp::FECollection<deal_II_dimension, deal_II_space_dimension> &);
 
+    template std::vector<unsigned int> SmoothnessEstimator::Fourier::
+      default_number_of_coefficients_per_direction<deal_II_dimension,
+                                                   deal_II_space_dimension>(
+        const hp::FECollection<deal_II_dimension, deal_II_space_dimension> &);
+    template hp::QCollection<deal_II_dimension> SmoothnessEstimator::Fourier::
+      default_quadrature_collection<deal_II_dimension, deal_II_space_dimension>(
+        const hp::FECollection<deal_II_dimension, deal_II_space_dimension> &);
 #endif
   }
index 9256a9c2d7f60840a52fe6fd6fa1d77cca85b2e3..b32b753f85fe5cde8487b7171a6cadd28f15a6be 100644 (file)
@@ -62,7 +62,11 @@ test_1d()
   QIterated<dim> quadrature(base_quadrature, N);
   q_collection.push_back(quadrature);
 
-  FESeries::Fourier<dim> fourier(N, fe_collection, q_collection);
+  const std::vector<unsigned int> n_coefficients_per_direction(1, N);
+
+  FESeries::Fourier<dim> fourier(n_coefficients_per_direction,
+                                 fe_collection,
+                                 q_collection);
 
   Vector<double> local_dof_values(2);
   local_dof_values[0]                     = 0;
index 4ee1807b591e457d512c32f535e673a44e0425f6..3f73031a536db0b89c138581543452cbd948ed2d 100644 (file)
@@ -106,8 +106,12 @@ test(const LegendreFunction<dim> &func, const unsigned int poly_degree)
 
   VectorTools::interpolate(dof_handler, func, values);
 
-  const unsigned int      N = poly_degree + 1;
-  FESeries::Legendre<dim> legendre(N, fe_collection, quadrature_formula);
+  const unsigned int              N = poly_degree + 1;
+  const std::vector<unsigned int> n_coefficients_per_direction(
+    fe_collection.size(), N);
+  FESeries::Legendre<dim> legendre(n_coefficients_per_direction,
+                                   fe_collection,
+                                   quadrature_formula);
 
   const std::vector<double> &coeff_in = func.get_coefficients();
   Table<1, double>           coeff_out(N);
index 0dbfbbeb1f195907c498cb7fc87a3eb0f101aa19..ff31decf46091376a266be95d744bbd0e48912b7 100644 (file)
@@ -1,6 +1,5 @@
 
 DEAL::L2_norm
-DEAL::0 : 0
 DEAL::1 : 4.12311
 DEAL::2 : 9.64365
 DEAL::3 : 16.4317
@@ -8,7 +7,6 @@ DEAL::4 : 17.8326
 DEAL::5 : 17.8045
 DEAL::6 : 15.0000
 DEAL::L1_norm
-DEAL::0 : 0
 DEAL::1 : 5.00000
 DEAL::2 : 15.0000
 DEAL::3 : 30.0000
@@ -16,7 +14,6 @@ DEAL::4 : 30.0000
 DEAL::5 : 25.0000
 DEAL::6 : 15.0000
 DEAL::Linfty_norm
-DEAL::0 : 0
 DEAL::1 : 4.00000
 DEAL::2 : 8.00000
 DEAL::3 : 12.0000
@@ -24,7 +21,6 @@ DEAL::4 : 13.0000
 DEAL::5 : 14.0000
 DEAL::6 : 15.0000
 DEAL::mean
-DEAL::0 : 0
 DEAL::1 : 2.50000
 DEAL::2 : 5.00000
 DEAL::3 : 7.50000
index e75cec9fdcd583d8f9adc34dbd41725fd59e9437..313e817bfdae88b2f99c17854cb393a657b65439 100644 (file)
@@ -104,8 +104,13 @@ test(const LegendreFunction<dim> &func, const unsigned int poly_degree)
   Vector<double> values(dof_handler.n_dofs());
 
   VectorTools::interpolate(dof_handler, func, values);
-  const unsigned int      N = 4;
-  FESeries::Legendre<dim> legendre(N, fe_collection, quadrature_formula);
+
+  const unsigned int              N = 4;
+  const std::vector<unsigned int> n_coefficients_per_direction(
+    fe_collection.size(), N);
+  FESeries::Legendre<dim> legendre(n_coefficients_per_direction,
+                                   fe_collection,
+                                   quadrature_formula);
 
   Table<1, double> coeff_out(N);
   Vector<double>   local_dof_values;
index b5c269b08bd660c6d6aef28045739ee42823b154..20ef90aa27d8b27e9a423eda5897ae6e40fb2888 100644 (file)
@@ -171,8 +171,12 @@ test(const LegendreFunction<dim> &func, const unsigned int poly_degree)
 
   VectorTools::interpolate(dof_handler, func, values);
 
-  const unsigned int      N = poly_degree + 1;
-  FESeries::Legendre<dim> legendre(N, fe_collection, quadrature_formula);
+  const unsigned int              N = poly_degree + 1;
+  const std::vector<unsigned int> n_coefficients_per_direction(
+    fe_collection.size(), N);
+  FESeries::Legendre<dim> legendre(n_coefficients_per_direction,
+                                   fe_collection,
+                                   quadrature_formula);
 
   const Table<dim, double> &coeff_in = func.get_coefficients();
   Table<dim, double>        coeff_out;
index f88adce0ab30406875b098c8cc14d8643f836c9e..a85d10a6305c250fe0e07f89d319e7078e3f83b4 100644 (file)
@@ -43,7 +43,13 @@ test_2d()
   for (unsigned int i = 0; i < fe_collection.size(); i++)
     fourier_q_collection.push_back(quadrature);
 
-  FESeries::Fourier<dim> fourier(N, fe_collection, fourier_q_collection);
+  const std::vector<unsigned int> n_coefficients_per_direction(
+    fe_collection.size(), N);
+
+  FESeries::Fourier<dim> fourier(n_coefficients_per_direction,
+                                 fe_collection,
+                                 fourier_q_collection);
+
   Table<dim, std::complex<double>> fourier_coefficients;
   fourier_coefficients.reinit(N, N);
 
index e7955ac5890f0a06a08a0e74582ceda6e30301a5..8e24248cd17e34dae3c9c2a9152670be7ead15e1 100644 (file)
@@ -1,21 +1,17 @@
 
 DEAL::L2_norm
-DEAL::0 : 0
 DEAL::1 : 4.12311
 DEAL::2 : 9.64365
 DEAL::3 : 16.4317
 DEAL::L1_norm
-DEAL::0 : 0
 DEAL::1 : 5.00000
 DEAL::2 : 15.0000
 DEAL::3 : 30.0000
 DEAL::Linfty_norm
-DEAL::0 : 0
 DEAL::1 : 4.00000
 DEAL::2 : 8.00000
 DEAL::3 : 12.0000
 DEAL::mean
-DEAL::0 : 0
 DEAL::1 : 2.50000
 DEAL::2 : 5.00000
 DEAL::3 : 7.50000
index a87e12949a6d10b549b9bbbd2697b967e65ef501..bbd65bf0c63679f8c9a6b313855886a4c317eb2b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
+
+
 // base header for hp-FEM test on Laplace equation.
 
+
 #include <deal.II/base/convergence_table.h>
 #include <deal.II/base/function.h>
 #include <deal.II/base/logstream.h>
@@ -30,6 +33,7 @@
 
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_q_hierarchical.h>
+#include <deal.II/fe/fe_series.h>
 #include <deal.II/fe/fe_system.h>
 #include <deal.II/fe/fe_tools.h>
 #include <deal.II/fe/fe_values.h>
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/lac/constraint_matrix.h>
+#include <deal.II/hp/dof_handler.h>
+#include <deal.II/hp/fe_collection.h>
+#include <deal.II/hp/q_collection.h>
+#include <deal.II/hp/refinement.h>
+
+#include <deal.II/lac/affine_constraints.h>
 #include <deal.II/lac/dynamic_sparsity_pattern.h>
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/precondition.h>
@@ -68,6 +77,8 @@
 
 #include "../tests.h"
 
+
+
 /**
  * Basic class for Laplace problem
  */
@@ -118,13 +129,10 @@ protected:
   mark_h_cells() = 0;
 
   /**
-   * remove h-refinement flag from some cells and populate @p p_cells with
-   * iterators to those cells, that shall be p-refined.
+   * remove h-refinement flag from some cells and flag cells for p-refinement
    */
-  virtual std::pair<unsigned int, unsigned int>
-  substitute_h_for_p(
-    std::vector<typename Triangulation<dim>::active_cell_iterator>
-      &p_cells) = 0;
+  virtual void
+  substitute_h_for_p() = 0;
 
   void
   refine_grid(const unsigned int cycle);
@@ -206,12 +214,16 @@ Laplace<dim>::Laplace(const Function<dim> &force_function,
   deallog << std::endl;
 }
 
+
+
 template <int dim>
 Laplace<dim>::~Laplace()
 {
   dof_handler.clear();
 }
 
+
+
 template <int dim>
 hp::DoFHandler<dim> &
 Laplace<dim>::get_dof_handler()
@@ -219,6 +231,8 @@ Laplace<dim>::get_dof_handler()
   return dof_handler;
 }
 
+
+
 template <int dim>
 void
 Laplace<dim>::setup_solve_estimate(Vector<float> &output_estimate)
@@ -230,6 +244,8 @@ Laplace<dim>::setup_solve_estimate(Vector<float> &output_estimate)
   output_estimate = estimated_error_per_cell;
 }
 
+
+
 template <int dim>
 void
 Laplace<dim>::setup_system()
@@ -285,6 +301,8 @@ Laplace<dim>::setup_system()
         << std::endl;
 }
 
+
+
 template <int dim>
 void
 Laplace<dim>::assemble()
@@ -352,6 +370,8 @@ Laplace<dim>::assemble()
   pcout << " done." << std::endl;
 }
 
+
+
 //#define DIRECT
 
 template <int dim>
@@ -397,6 +417,8 @@ Laplace<dim>::solve()
   pcout << " done." << std::endl;
 }
 
+
+
 template <int dim>
 void
 Laplace<dim>::refine_grid(const unsigned int cycle)
@@ -407,11 +429,20 @@ Laplace<dim>::refine_grid(const unsigned int cycle)
   mark_h_cells();
 
   // 3.3. Substitute h for p refinement
-  std::vector<typename Triangulation<dim>::active_cell_iterator> p_cells;
-  hp_number = substitute_h_for_p(p_cells);
+  substitute_h_for_p();
 
+  // prepare refinement and store number of flagged cells
   triangulation.prepare_coarsening_and_refinement();
 
+  hp_number = {0, 0};
+  for (const auto &cell : dof_handler.active_cell_iterators())
+    {
+      if (cell->refine_flag_set())
+        ++hp_number.first;
+      if (cell->future_fe_index_set())
+        ++hp_number.second;
+    }
+
   // 3.4. Solution Transfer
   SolutionTransfer<dim, TrilinosWrappers::MPI::Vector, hp::DoFHandler<dim>>
     soltrans(dof_handler);
@@ -424,18 +455,7 @@ Laplace<dim>::refine_grid(const unsigned int cycle)
   solution_coarse = solution;
   soltrans.prepare_for_coarsening_and_refinement(solution_coarse);
 
-  // increase fe_index()
-  for (unsigned int i = 0; i < p_cells.size(); i++)
-    {
-      typename hp::DoFHandler<dim>::active_cell_iterator cell(
-        &triangulation, p_cells[i]->level(), p_cells[i]->index(), &dof_handler);
-
-      const unsigned int incremented_index = cell->active_fe_index() + 1;
-      Assert(incremented_index < fe.size(), ExcInternalError());
-      cell->set_active_fe_index(incremented_index);
-    }
-
-  // 3.5. Refinement
+  // 3.5. h-refinement and p-refinement
   triangulation.execute_coarsening_and_refinement();
 
   // FIXME: some hp strategies might need:
@@ -448,6 +468,8 @@ Laplace<dim>::refine_grid(const unsigned int cycle)
   soltrans.interpolate(solution_coarse, solution);
 }
 
+
+
 template <int dim>
 void
 Laplace<dim>::calculate_error()
@@ -535,6 +557,8 @@ Laplace<dim>::calculate_error()
   Linfty_error = Utilities::MPI::max(Linfty_error, mpi_communicator);
 }
 
+
+
 template <int dim>
 void
 Laplace<dim>::output_results(int cycle)
@@ -557,6 +581,8 @@ Laplace<dim>::output_results(int cycle)
             << Linfty_error << sp << total_error << sp << std::endl;
 }
 
+
+
 template <int dim>
 void
 Laplace<dim>::print_errors()
@@ -603,6 +629,8 @@ Laplace<dim>::print_errors()
     }
 }
 
+
+
 template <int dim>
 void
 Laplace<dim>::run()
diff --git a/tests/hp/laplace_mitchel2014_04_peak.output b/tests/hp/laplace_mitchel2014_04_peak.output
deleted file mode 100644 (file)
index 7bcfbb5..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-
-DEAL::
-DEAL::0 256 0 0 289 0.267081 1.78414 1.23386 1.29971 
-DEAL::1 256 0 56 477 0.0236257 0.743531 0.249786 1.18708 
-DEAL::2 268 4 48 801 0.00108376 0.293919 0.0466411 0.361176 
-DEAL::3 349 22 32 1730 0.000121568 0.0610935 0.00469929 0.0464975 
-DEAL::4 421 18 52 2818 3.08015e-05 0.0204013 0.00315297 0.0197872 
-DEAL::5 496 11 74 4632 6.14178e-06 0.00604078 0.000714754 0.00530244 
-DEAL::6 622 28 72 7303 2.03947e-06 0.00210333 0.000148863 0.00185557 
-DEAL::7 712 17 108 10086 5.30920e-07 0.000744017 7.24474e-05 0.000775517 
-DEAL::8 811 20 123 13127 2.97635e-07 0.000379131 3.62580e-05 0.000400767 
-DEAL::9 901 15 148 17913 1.18544e-07 0.000194730 1.48736e-05 0.000216587 
-DEAL::10 1030 20 161 23692 4.78884e-08 0.000106719 9.54505e-06 0.000117773 
similarity index 78%
rename from tests/hp/laplace_mitchel2014_04_peak.cc
rename to tests/hp/laplace_mitchell2014_04_peak.cc
index 0cc813c60e608d584ee08494550be87af3d06fa5..26d7c49527cbcd194a8408e59be7025cd94475b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-// test SmoothnessEstimator::legendre_coefficient_decay() on
-// problem 4 (peak) in Mitchel 2014.
+
+
+// test SmoothnessEstimator::Legendre::coefficient_decay_per_direction()
+// on problem 4 (peak) in Mitchell 2014.
+
 
 #include "laplace.h"
 
@@ -103,12 +106,14 @@ private:
   estimate_error();
   void
   mark_h_cells();
-
-  std::pair<unsigned int, unsigned int>
-  substitute_h_for_p(
-    std::vector<typename Triangulation<dim>::active_cell_iterator> &p_cells);
+  void
+  substitute_h_for_p();
 
   hp::QCollection<dim - 1> quadrature_face;
+
+  std::vector<unsigned int> n_coefficients_per_direction;
+  hp::QCollection<dim>      expansion_q_collection;
+  FESeries::Legendre<dim>   legendre;
 };
 
 template <int dim>
@@ -135,45 +140,42 @@ Problem4<dim>::Problem4(const Function<dim> &force_function,
       const QIterated<dim> q_iterated(q_trapez, p + 3);
       Laplace<dim>::quadrature_infty.push_back(QSorted<dim>(q_iterated));
     }
+
+  // after the FECollection has been generated, create a corresponding legendre
+  // series expansion object
+  n_coefficients_per_direction =
+    SmoothnessEstimator::Legendre::default_number_of_coefficients_per_direction(
+      Laplace<dim>::fe);
+  expansion_q_collection =
+    SmoothnessEstimator::Legendre::default_quadrature_collection(
+      Laplace<dim>::fe);
+  legendre.initialize(n_coefficients_per_direction,
+                      Laplace<dim>::fe,
+                      expansion_q_collection);
 }
 
 
 
 template <int dim>
-std::pair<unsigned int, unsigned int>
-Problem4<dim>::substitute_h_for_p(
-  std::vector<typename Triangulation<dim>::active_cell_iterator> &p_cells)
+void
+Problem4<dim>::substitute_h_for_p()
 {
   Vector<float> smoothness_indicators(
     Laplace<dim>::triangulation.n_active_cells());
-  SmoothnessEstimator::legendre_coefficient_decay(Laplace<dim>::dof_handler,
-                                                  Laplace<dim>::solution,
-                                                  smoothness_indicators);
-
-  unsigned int num_p_cells = 0;
-  unsigned int num_h_cells = 0;
-  for (auto &cell : Laplace<dim>::dof_handler.active_cell_iterators())
-    if (cell->refine_flag_set())
-      {
-        typename Triangulation<dim>::active_cell_iterator tria_cell(
-          &(Laplace<dim>::triangulation), cell->level(), cell->index());
-
-        const unsigned int cur_fe_index = cell->active_fe_index();
-        const bool p_ref = smoothness_indicators(cell->index()) < exp(-1.);
-
-        if (cur_fe_index < Laplace<dim>::fe.size() - 1 && p_ref)
-          {
-            ++num_p_cells;
-            cell->clear_refine_flag();
-            p_cells.push_back(tria_cell);
-          }
-        else
-          {
-            ++num_h_cells;
-          }
-      }
-
-  return std::make_pair(num_h_cells, num_p_cells);
+  SmoothnessEstimator::Legendre::coefficient_decay_per_direction(
+    legendre,
+    Laplace<dim>::dof_handler,
+    Laplace<dim>::solution,
+    smoothness_indicators);
+
+  hp::Refinement::p_adaptivity_from_absolute_threshold(
+    Laplace<dim>::dof_handler,
+    smoothness_indicators,
+    static_cast<float>(1.),
+    static_cast<float>(0.),
+    std::greater<float>(),
+    std::less<float>());
+  hp::Refinement::choose_p_over_h(Laplace<dim>::dof_handler);
 }
 
 
diff --git a/tests/hp/laplace_mitchell2014_04_peak.with_trilinos=true.output b/tests/hp/laplace_mitchell2014_04_peak.with_trilinos=true.output
new file mode 100644 (file)
index 0000000..87817c4
--- /dev/null
@@ -0,0 +1,13 @@
+
+DEAL::
+DEAL::0 256 0 0 289 0.267081 1.78414 1.23386 1.29971 
+DEAL::1 256 0 56 477 0.0236257 0.743531 0.249786 1.18708 
+DEAL::2 268 4 47 790 0.00108376 0.293919 0.0466411 0.361176 
+DEAL::3 328 20 33 1498 0.000182183 0.0621768 0.00717343 0.0760236 
+DEAL::4 508 60 24 3402 2.40462e-05 0.0134610 0.00111509 0.0224341 
+DEAL::5 571 21 80 4536 3.48748e-06 0.00249342 0.000176335 0.00398940 
+DEAL::6 595 8 106 5758 7.30475e-07 0.000644499 3.23861e-05 0.000860213 
+DEAL::7 673 26 93 7725 3.32389e-07 0.000304984 2.38742e-05 0.000356132 
+DEAL::8 721 16 118 9246 5.75345e-08 7.11276e-05 2.90017e-06 0.000111393 
+DEAL::9 772 17 127 11000 3.50959e-08 3.79011e-05 2.91724e-06 5.96652e-05 
+DEAL::10 796 8 146 13074 9.97255e-09 1.29806e-05 7.46491e-07 1.99550e-05 
index 857c7163ff651f86ca65e04e37a32491c063b351..eafadd5c0eeb01c8eb40b43811bf306b0535d02a 100644 (file)
@@ -29,6 +29,7 @@
 #include <deal.II/dofs/dof_tools.h>
 
 #include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_series.h>
 
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_refinement.h>
@@ -38,6 +39,8 @@
 
 #include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_values.h>
+#include <deal.II/hp/q_collection.h>
+#include <deal.II/hp/refinement.h>
 
 #include <deal.II/lac/affine_constraints.h>
 #include <deal.II/lac/dynamic_sparsity_pattern.h>
@@ -101,7 +104,9 @@ namespace Step27
     Vector<double> solution;
     Vector<double> system_rhs;
 
-    const unsigned int max_degree;
+    const unsigned int     max_degree;
+    hp::QCollection<dim>   fourier_q_collection;
+    FESeries::Fourier<dim> fourier;
   };
 
 
@@ -142,6 +147,17 @@ namespace Step27
         quadrature_collection.push_back(QGauss<dim>(degree + 1));
         face_quadrature_collection.push_back(QGauss<dim - 1>(degree + 1));
       }
+
+    QGauss<1>      base_quadrature(2);
+    QIterated<dim> quadrature(base_quadrature, max_degree);
+    for (unsigned int i = 0; i < fe_collection.size(); ++i)
+      fourier_q_collection.push_back(quadrature);
+
+    const std::vector<unsigned int> n_coefficients_per_direction(
+      fe_collection.size(), max_degree);
+    fourier.initialize(n_coefficients_per_direction,
+                       fe_collection,
+                       fourier_q_collection);
   }
 
 
@@ -269,10 +285,26 @@ namespace Step27
       solution,
       estimated_error_per_cell);
 
+    GridRefinement::refine_and_coarsen_fixed_number(triangulation,
+                                                    estimated_error_per_cell,
+                                                    0.3,
+                                                    0.03);
+
     Vector<float> smoothness_indicators;
-    SmoothnessEstimator::fourier_coefficient_decay(dof_handler,
-                                                   solution,
-                                                   smoothness_indicators);
+    SmoothnessEstimator::Fourier::coefficient_decay(
+      fourier,
+      dof_handler,
+      solution,
+      smoothness_indicators,
+      /*regression_strategy=*/VectorTools::Linfty_norm,
+      /*smallest_abs_coefficient=*/1e-10,
+      /*only_flagged_cells=*/true);
+
+    hp::Refinement::p_adaptivity_from_relative_threshold(dof_handler,
+                                                         smoothness_indicators,
+                                                         0.5,
+                                                         0);
+    hp::Refinement::choose_p_over_h(dof_handler);
 
     // Output to VTK
     if (false)
@@ -302,50 +334,7 @@ namespace Step27
         data_out.write_vtk(output);
       }
 
-    {
-      GridRefinement::refine_and_coarsen_fixed_number(triangulation,
-                                                      estimated_error_per_cell,
-                                                      0.3,
-                                                      0.03);
-
-      float max_smoothness = *std::min_element(smoothness_indicators.begin(),
-                                               smoothness_indicators.end()),
-            min_smoothness = *std::max_element(smoothness_indicators.begin(),
-                                               smoothness_indicators.end());
-      {
-        typename hp::DoFHandler<dim>::active_cell_iterator
-          cell = dof_handler.begin_active(),
-          endc = dof_handler.end();
-        for (; cell != endc; ++cell)
-          if (cell->refine_flag_set())
-            {
-              max_smoothness =
-                std::max(max_smoothness,
-                         smoothness_indicators(cell->active_cell_index()));
-              min_smoothness =
-                std::min(min_smoothness,
-                         smoothness_indicators(cell->active_cell_index()));
-            }
-      }
-      const float threshold_smoothness = (max_smoothness + min_smoothness) / 2;
-
-      {
-        typename hp::DoFHandler<dim>::active_cell_iterator
-          cell = dof_handler.begin_active(),
-          endc = dof_handler.end();
-        for (; cell != endc; ++cell)
-          if (cell->refine_flag_set() &&
-              (smoothness_indicators(cell->active_cell_index()) >
-               threshold_smoothness) &&
-              (cell->active_fe_index() + 1 < fe_collection.size()))
-            {
-              cell->clear_refine_flag();
-              cell->set_active_fe_index(cell->active_fe_index() + 1);
-            }
-      }
-
-      triangulation.execute_coarsening_and_refinement();
-    }
+    triangulation.execute_coarsening_and_refinement();
   }
 
 
index 322ba6b3387622ac2c8968d58d957835ab8b1db5..eb95c3caffb934c0ab141a03e307670e66515544 100644 (file)
@@ -47,6 +47,7 @@ namespace LA
 
 #include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_values.h>
+#include <deal.II/hp/q_collection.h>
 #include <deal.II/hp/refinement.h>
 
 #include <deal.II/lac/affine_constraints.h>
@@ -59,6 +60,7 @@ namespace LA
 #include <deal.II/numerics/data_out.h>
 #include <deal.II/numerics/error_estimator.h>
 #include <deal.II/numerics/matrix_tools.h>
+#include <deal.II/numerics/smoothness_estimator.h>
 #include <deal.II/numerics/vector_tools.h>
 
 #include <complex>
@@ -105,10 +107,8 @@ namespace Step27
     hp::QCollection<dim>     quadrature_collection;
     hp::QCollection<dim - 1> face_quadrature_collection;
 
-    hp::QCollection<dim>                    fourier_q_collection;
-    std::shared_ptr<FESeries::Fourier<dim>> fourier;
-    std::vector<double>                     ln_k;
-    Table<dim, std::complex<double>>        fourier_coefficients;
+    hp::QCollection<dim>   fourier_q_collection;
+    FESeries::Fourier<dim> fourier;
 
     AffineConstraints<double> constraints;
 
@@ -181,18 +181,16 @@ namespace Step27
         face_quadrature_collection.push_back(QGauss<dim - 1>(degree + 1));
       }
 
-    const unsigned int N = max_degree;
-
     QGauss<1>      base_quadrature(2);
-    QIterated<dim> quadrature(base_quadrature, N);
+    QIterated<dim> quadrature(base_quadrature, max_degree);
     for (unsigned int i = 0; i < fe_collection.size(); i++)
       fourier_q_collection.push_back(quadrature);
 
-    fourier = std::make_shared<FESeries::Fourier<dim>>(N,
-                                                       fe_collection,
-                                                       fourier_q_collection);
-
-    resize(fourier_coefficients, N);
+    const std::vector<unsigned int> n_coefficients_per_direction(
+      fe_collection.size(), max_degree);
+    fourier.initialize(n_coefficients_per_direction,
+                       fe_collection,
+                       fourier_q_collection);
   }
 
 
@@ -373,12 +371,19 @@ namespace Step27
       solution,
       estimated_error_per_cell);
 
-    Vector<float> smoothness_indicators(triangulation.n_active_cells());
-    estimate_smoothness(smoothness_indicators);
-
     parallel::distributed::GridRefinement::refine_and_coarsen_fixed_number(
       triangulation, estimated_error_per_cell, 0.3, 0.03);
 
+    Vector<float> smoothness_indicators(triangulation.n_active_cells());
+    SmoothnessEstimator::Fourier::coefficient_decay(
+      fourier,
+      dof_handler,
+      solution,
+      smoothness_indicators,
+      /*regression_strategy=*/VectorTools::Linfty_norm,
+      /*smallest_abs_coefficient=*/1e-10,
+      /*only_flagged_cells=*/true);
+
     hp::Refinement::p_adaptivity_from_relative_threshold(dof_handler,
                                                          smoothness_indicators,
                                                          0.5,
@@ -460,68 +465,6 @@ namespace Step27
         postprocess();
       }
   }
-
-
-
-  template <int dim>
-  std::pair<bool, unsigned int>
-  LaplaceProblem<dim>::predicate(const TableIndices<dim> &ind)
-  {
-    unsigned int v = 0;
-    for (unsigned int i = 0; i < dim; i++)
-      v += ind[i] * ind[i];
-    if (v > 0 && v < max_degree * max_degree)
-      return std::make_pair(true, v);
-    else
-      return std::make_pair(false, v);
-  }
-
-
-
-  template <int dim>
-  void
-  LaplaceProblem<dim>::estimate_smoothness(Vector<float> &smoothness_indicators)
-  {
-    Vector<double> local_dof_values;
-
-    for (const auto &cell : dof_handler.active_cell_iterators())
-      if (cell->is_locally_owned())
-        {
-          local_dof_values.reinit(cell->get_fe().dofs_per_cell);
-          cell->get_dof_values(solution, local_dof_values);
-
-          fourier->calculate(local_dof_values,
-                             cell->active_fe_index(),
-                             fourier_coefficients);
-
-          std::pair<std::vector<unsigned int>, std::vector<double>> res =
-            FESeries::process_coefficients<dim>(
-              fourier_coefficients,
-              std::bind(&LaplaceProblem<dim>::predicate,
-                        this,
-                        std::placeholders::_1),
-              VectorTools::Linfty_norm);
-
-          Assert(res.first.size() == res.second.size(), ExcInternalError());
-
-          if (ln_k.size() == 0)
-            {
-              ln_k.resize(res.first.size(), 0);
-              for (unsigned int f = 0; f < ln_k.size(); f++)
-                ln_k[f] =
-                  std::log(2.0 * numbers::PI * std::sqrt(1. * res.first[f]));
-            }
-
-          for (double &residual_element : res.second)
-            residual_element = std::log(residual_element);
-
-          std::pair<double, double> fit =
-            FESeries::linear_regression(ln_k, res.second);
-
-          smoothness_indicators(cell->active_cell_index()) =
-            -fit.first - 1. * dim / 2;
-        }
-  }
 } // namespace Step27
 
 
index 2dde52358ad8d670f6a9c18a537a550cd76a52fc..692a3c2c6139711020a0bb6874d5fc529e62d3e9 100644 (file)
@@ -47,6 +47,7 @@ namespace LA
 
 #include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_values.h>
+#include <deal.II/hp/q_collection.h>
 #include <deal.II/hp/refinement.h>
 
 #include <deal.II/lac/affine_constraints.h>
@@ -59,6 +60,7 @@ namespace LA
 #include <deal.II/numerics/data_out.h>
 #include <deal.II/numerics/error_estimator.h>
 #include <deal.II/numerics/matrix_tools.h>
+#include <deal.II/numerics/smoothness_estimator.h>
 #include <deal.II/numerics/vector_tools.h>
 
 #include <complex>
@@ -105,10 +107,8 @@ namespace Step27
     hp::QCollection<dim>     quadrature_collection;
     hp::QCollection<dim - 1> face_quadrature_collection;
 
-    hp::QCollection<dim>                    fourier_q_collection;
-    std::shared_ptr<FESeries::Fourier<dim>> fourier;
-    std::vector<double>                     ln_k;
-    Table<dim, std::complex<double>>        fourier_coefficients;
+    hp::QCollection<dim>   fourier_q_collection;
+    FESeries::Fourier<dim> fourier;
 
     AffineConstraints<double> constraints;
 
@@ -181,18 +181,16 @@ namespace Step27
         face_quadrature_collection.push_back(QGauss<dim - 1>(degree + 1));
       }
 
-    const unsigned int N = max_degree;
-
     QGauss<1>      base_quadrature(2);
-    QIterated<dim> quadrature(base_quadrature, N);
+    QIterated<dim> quadrature(base_quadrature, max_degree);
     for (unsigned int i = 0; i < fe_collection.size(); i++)
       fourier_q_collection.push_back(quadrature);
 
-    fourier = std::make_shared<FESeries::Fourier<dim>>(N,
-                                                       fe_collection,
-                                                       fourier_q_collection);
-
-    resize(fourier_coefficients, N);
+    const std::vector<unsigned int> n_coefficients_per_direction(
+      fe_collection.size(), max_degree);
+    fourier.initialize(n_coefficients_per_direction,
+                       fe_collection,
+                       fourier_q_collection);
   }
 
 
@@ -374,13 +372,19 @@ namespace Step27
       solution,
       estimated_error_per_cell);
 
-
-    Vector<float> smoothness_indicators(triangulation.n_active_cells());
-    estimate_smoothness(smoothness_indicators);
-
     parallel::distributed::GridRefinement::refine_and_coarsen_fixed_number(
       triangulation, estimated_error_per_cell, 0.3, 0.03);
 
+    Vector<float> smoothness_indicators(triangulation.n_active_cells());
+    SmoothnessEstimator::Fourier::coefficient_decay(
+      fourier,
+      dof_handler,
+      solution,
+      smoothness_indicators,
+      /*regression_strategy=*/VectorTools::Linfty_norm,
+      /*smallest_abs_coefficient=*/1e-10,
+      /*only_flagged_cells=*/true);
+
     hp::Refinement::p_adaptivity_from_relative_threshold(dof_handler,
                                                          smoothness_indicators,
                                                          0.5,
@@ -462,68 +466,6 @@ namespace Step27
         postprocess();
       }
   }
-
-
-
-  template <int dim>
-  std::pair<bool, unsigned int>
-  LaplaceProblem<dim>::predicate(const TableIndices<dim> &ind)
-  {
-    unsigned int v = 0;
-    for (unsigned int i = 0; i < dim; i++)
-      v += ind[i] * ind[i];
-    if (v > 0 && v < max_degree * max_degree)
-      return std::make_pair(true, v);
-    else
-      return std::make_pair(false, v);
-  }
-
-
-
-  template <int dim>
-  void
-  LaplaceProblem<dim>::estimate_smoothness(Vector<float> &smoothness_indicators)
-  {
-    Vector<double> local_dof_values;
-
-    for (const auto &cell : dof_handler.active_cell_iterators())
-      if (cell->is_locally_owned())
-        {
-          local_dof_values.reinit(cell->get_fe().dofs_per_cell);
-          cell->get_dof_values(solution, local_dof_values);
-
-          fourier->calculate(local_dof_values,
-                             cell->active_fe_index(),
-                             fourier_coefficients);
-
-          std::pair<std::vector<unsigned int>, std::vector<double>> res =
-            FESeries::process_coefficients<dim>(
-              fourier_coefficients,
-              std::bind(&LaplaceProblem<dim>::predicate,
-                        this,
-                        std::placeholders::_1),
-              VectorTools::Linfty_norm);
-
-          Assert(res.first.size() == res.second.size(), ExcInternalError());
-
-          if (ln_k.size() == 0)
-            {
-              ln_k.resize(res.first.size(), 0);
-              for (unsigned int f = 0; f < ln_k.size(); f++)
-                ln_k[f] =
-                  std::log(2.0 * numbers::PI * std::sqrt(1. * res.first[f]));
-            }
-
-          for (double &residual_element : res.second)
-            residual_element = std::log(residual_element);
-
-          std::pair<double, double> fit =
-            FESeries::linear_regression(ln_k, res.second);
-
-          smoothness_indicators(cell->active_cell_index()) =
-            -fit.first - 1. * dim / 2;
-        }
-  }
 } // namespace Step27
 
 
index 13b3e41b660bea64da0157e8c288ac3bc54ffbc9..a08429ace5432b980b177317b96343b7d2629ffb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
+
+
 // essentially similar to fe/fe_series_05.cc but test smoothness estimation.
+
+
 #include <deal.II/base/function.h>
 #include <deal.II/base/quadrature_lib.h>
 
+#include <deal.II/fe/component_mask.h>
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_series.h>
 
 
 #include "../tests.h"
 
+
 using namespace dealii;
 
+
 template <int dim>
 class LegendreFunction : public Function<dim>
 {
@@ -61,6 +68,8 @@ private:
   const Table<dim, double> coefficients;
 };
 
+
+
 // copy-paste from fe_series.cc
 template <int dim>
 double
@@ -78,6 +87,8 @@ Lh(const Point<dim> &x_q, const TableIndices<dim> &indices)
   return res;
 }
 
+
+
 template <>
 double
 LegendreFunction<2>::value(const dealii::Point<2> &point,
@@ -107,6 +118,8 @@ LegendreFunction<3>::value(const dealii::Point<3> &point,
   return f;
 }
 
+
+
 void
 compare(const Table<2, double> &coeff1, const Table<2, double> &coeff2)
 {
@@ -134,6 +147,8 @@ compare(const Table<3, double> &coeff1, const Table<3, double> &coeff2)
           << linf << std::endl;
 }
 
+
+
 void resize(Table<2, double> &coeff, const unsigned int N)
 {
   coeff.reinit(N, N);
@@ -153,45 +168,48 @@ template <int dim>
 void
 test(const LegendreFunction<dim> &func, const unsigned int poly_degree)
 {
-  // custom predicate:
-  // p-ref for linear elements and use j=1,...,pe otherwise.
-  const auto coefficients_predicate = [](std::vector<bool> &flags) -> void {
-    std::fill(flags.begin(), flags.end(), flags.size() > 2);
-    flags[0] = false;
-  };
-
   const unsigned int max_poly = poly_degree + 3;
   deallog << "-----------------------------------" << std::endl;
   deallog << dim << "d, p=" << poly_degree << ", max_p=" << max_poly
           << std::endl;
   deallog << "-----------------------------------" << std::endl;
-  Triangulation<dim>    triangulation;
-  hp::DoFHandler<dim>   dof_handler(triangulation);
-  hp::FECollection<dim> fe_collection;
-  hp::QCollection<dim>  quadrature_formula;
 
   // add some extra FEs in fe_collection
+  hp::FECollection<dim> fe_collection;
   for (unsigned int p = 1; p <= max_poly; p++)
-    {
-      fe_collection.push_back(FE_Q<dim>(p));
-      quadrature_formula.push_back(QGauss<dim>(p + 1 + 5));
-    }
+    fe_collection.push_back(FE_Q<dim>(p));
+
+  const unsigned int              fe_index = poly_degree - 1;
+  const std::vector<unsigned int> n_coefficients_per_direction =
+    SmoothnessEstimator::Legendre::default_number_of_coefficients_per_direction(
+      fe_collection);
+  const unsigned int n_modes = n_coefficients_per_direction[fe_index];
+
+  // custom predicate:
+  // p-ref for linear elements and use j=1,...,pe otherwise.
+  ComponentMask coefficients_predicate(n_modes, true);
+  coefficients_predicate.set(0, false);
 
+  Triangulation<dim> triangulation;
   GridGenerator::hyper_cube(triangulation, 0.0, 1.0); // reference cell
-  const unsigned int fe_index = poly_degree - 1;
+
+  hp::DoFHandler<dim> dof_handler(triangulation);
+  dof_handler.set_fe(fe_collection);
   dof_handler.begin_active()->set_active_fe_index(fe_index);
   dof_handler.distribute_dofs(fe_collection);
 
   Vector<double> values(dof_handler.n_dofs());
-
   VectorTools::interpolate(dof_handler, func, values);
 
-  const unsigned int      N = poly_degree + 1;
-  FESeries::Legendre<dim> legendre(N, fe_collection, quadrature_formula);
+  hp::QCollection<dim> q_collection =
+    SmoothnessEstimator::Legendre::default_quadrature_collection(fe_collection);
+  FESeries::Legendre<dim> legendre(n_coefficients_per_direction,
+                                   fe_collection,
+                                   q_collection);
 
   const Table<dim, double> &coeff_in = func.get_coefficients();
   Table<dim, double>        coeff_out;
-  resize(coeff_out, N);
+  resize(coeff_out, n_modes);
 
   Vector<double> local_dof_values;
 
@@ -211,14 +229,22 @@ test(const LegendreFunction<dim> &func, const unsigned int poly_degree)
 
   // finally test smoothness estimator:
   Vector<float> smoothness(1);
-  SmoothnessEstimator::legendre_coefficient_decay(
-    legendre, dof_handler, values, smoothness, coefficients_predicate);
+  SmoothnessEstimator::Legendre::coefficient_decay_per_direction(
+    legendre,
+    dof_handler,
+    values,
+    smoothness,
+    coefficients_predicate,
+    /*smallest_abs_coefficient=*/1e-10,
+    /*only_flagged_cells=*/false);
 
   deallog << "smoothness:" << std::endl << smoothness[0] << std::endl;
 
   dof_handler.clear();
 }
 
+
+
 int
 main()
 {
@@ -239,7 +265,8 @@ main()
 
     LegendreFunction<dim> function(coeff_in);
     test(function, p);
-    deallog << "expected smoothness:" << std::endl << 0. << std::endl;
+    deallog << "expected smoothness:" << std::endl
+            << std::numeric_limits<float>::infinity() << std::endl;
   }
 
   // for quadratic we can already assign exponential decay:   a_i = C exp ( -k
@@ -266,7 +293,7 @@ main()
     test(function, p);
 
     deallog << "expected smoothness:" << std::endl
-            << exp(-std::min(k1, k2)) << std::endl;
+            << std::min(k1, k2) << std::endl;
   }
 
   // linear elements in 3D (expect zero output)
@@ -283,7 +310,8 @@ main()
 
     LegendreFunction<dim> function(coeff_in);
     test(function, p);
-    deallog << "expected smoothness:" << std::endl << 0. << std::endl;
+    deallog << "expected smoothness:" << std::endl
+            << std::numeric_limits<float>::infinity() << std::endl;
   }
 
   // cubic in 3D
@@ -311,7 +339,7 @@ main()
     test(function, p);
 
     deallog << "expected smoothness:" << std::endl
-            << exp(-std::min(k1, std::min(k2, k3))) << std::endl;
+            << std::min(k1, std::min(k2, k3)) << std::endl;
   }
 
 
@@ -342,7 +370,7 @@ main()
     LegendreFunction<dim> function(coeff_in);
     test(function, p);
 
-    deallog << "expected smoothness:" << std::endl << exp(-k1) << std::endl;
+    deallog << "expected smoothness:" << std::endl << k1 << std::endl;
   }
 
   // cubic in 3D (zero)
@@ -355,7 +383,8 @@ main()
     LegendreFunction<dim> function(coeff_in);
     test(function, p);
 
-    deallog << "expected smoothness:" << std::endl << 0. << std::endl;
+    deallog << "expected smoothness:" << std::endl
+            << std::numeric_limits<float>::infinity() << std::endl;
   }
 
   dealii::deallog << "Ok" << std::endl;
index 65d1adcafbcfc63b4d4d4ed159bac2e47af67201..f655fa0cd8b6a3ba61e4ed2531391623981259cf 100644 (file)
@@ -2,54 +2,54 @@ DEAL::-----------------------------------
 DEAL::2d, p=1, max_p=4
 DEAL::-----------------------------------
 DEAL::Linf norm in exact and calculate Legendre coefficients:
-DEAL::1.77636e-15
+DEAL::1.33227e-15
 DEAL::smoothness:
-DEAL::0.00000
+DEAL::inf
 DEAL::expected smoothness:
-DEAL::0.00000
+DEAL::inf
 DEAL::-----------------------------------
 DEAL::2d, p=2, max_p=5
 DEAL::-----------------------------------
 DEAL::Linf norm in exact and calculate Legendre coefficients:
-DEAL::7.21645e-16
+DEAL::7.27596e-12
 DEAL::smoothness:
-DEAL::0.367879
+DEAL::1.00000
 DEAL::expected smoothness:
-DEAL::0.367879
+DEAL::1.00000
 DEAL::-----------------------------------
 DEAL::3d, p=1, max_p=4
 DEAL::-----------------------------------
 DEAL::Linf norm in exact and calculate Legendre coefficients:
-DEAL::3.55271e-15
+DEAL::1.77636e-15
 DEAL::smoothness:
-DEAL::0.00000
+DEAL::inf
 DEAL::expected smoothness:
-DEAL::0.00000
+DEAL::inf
 DEAL::-----------------------------------
 DEAL::3d, p=3, max_p=6
 DEAL::-----------------------------------
 DEAL::Linf norm in exact and calculate Legendre coefficients:
-DEAL::3.19189e-15
+DEAL::1.38017e-11
 DEAL::smoothness:
-DEAL::0.135335
+DEAL::2.00000
 DEAL::expected smoothness:
-DEAL::0.135335
+DEAL::2.00000
 DEAL::-----------------------------------
 DEAL::3d, p=4, max_p=7
 DEAL::-----------------------------------
 DEAL::Linf norm in exact and calculate Legendre coefficients:
-DEAL::4.31599e-15
+DEAL::1.31877e-11
 DEAL::smoothness:
-DEAL::0.135335
+DEAL::2.00000
 DEAL::expected smoothness:
-DEAL::0.135335
+DEAL::2.00000
 DEAL::-----------------------------------
 DEAL::3d, p=3, max_p=6
 DEAL::-----------------------------------
 DEAL::Linf norm in exact and calculate Legendre coefficients:
 DEAL::0.00000
 DEAL::smoothness:
-DEAL::0.00000
+DEAL::inf
 DEAL::expected smoothness:
-DEAL::0.00000
+DEAL::inf
 DEAL::Ok
diff --git a/tests/numerics/smoothness_estimator_02.cc b/tests/numerics/smoothness_estimator_02.cc
new file mode 100644 (file)
index 0000000..0b59a52
--- /dev/null
@@ -0,0 +1,329 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2019 - 2020 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
+//
+// ---------------------------------------------------------------------
+
+
+
+// Check Fourier coefficient for simple functions in 1D/2D/3D.
+// Further, estimate regularity in 1D/2D/3D.
+// Similar to tests fe/fe_series_01.cc and numerics/smoothness_estimator_01.cc.
+
+// Test functions: 1D: x^p, 2D: (x*y)^p, 3D: (x*y*z)^p
+// Below is the MWE in Maxima for x*y*z:
+/*********************************************************
+integrate2(F,xx,aa,bb,yy,cc,dd):=block(integrate(integrate(F,xx,aa,bb),yy,cc,dd));
+integrate3(F,xx,aa,bb,yy,cc,dd,zz,ee,ff):=block(integrate(integrate(integrate(F,xx,aa,bb),yy,cc,dd),zz,ee,ff));
+a:0;
+b:1;
+nmax:3;
+Phi(xx,nn):=exp(((-2)*%i*%pi*nn*xx)/(b-a));
+Phi2(xx,nn,yy,mm):=Phi(xx,nn)*Phi(yy,mm);
+Phi3(xx,nn,yy,mm,zz,ll):=Phi(xx,nn)*Phi(yy,mm)*Phi(zz,ll);
+f3:x*y*z;
+C3(n,m,l):=integrate3(f3*conjugate(Phi3(x,n,y,m,z,l)),x,a,b,y,a,b,z,a,b)/(b-a)^3;
+load(functs);
+for i:0 thru nmax do (for j:0 thru nmax do (for k:0 thru nmax do
+print([i,j,k],fullratsimp(C3(i,j,k)))));
+*********************************************************/
+
+
+#include <deal.II/base/function.h>
+#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/base/table.h>
+
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_series.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/tria.h>
+
+#include <deal.II/hp/dof_handler.h>
+#include <deal.II/hp/q_collection.h>
+
+#include <deal.II/lac/vector.h>
+
+#include <deal.II/numerics/smoothness_estimator.h>
+#include <deal.II/numerics/vector_tools.h>
+
+#include <cmath>
+#include <iostream>
+
+#include "../tests.h"
+
+
+using namespace dealii;
+
+
+template <int dim>
+class PolyFunction : public Function<dim>
+{
+public:
+  PolyFunction(const unsigned int poly_degree)
+    : Function<dim>(1)
+    , poly_degree(poly_degree)
+  {}
+
+  virtual double
+  value(const Point<dim> &point, const unsigned int component = 0) const;
+
+private:
+  const unsigned int poly_degree;
+};
+
+
+
+template <int dim>
+double
+PolyFunction<dim>::value(const Point<dim> &point, const unsigned int) const
+{
+  double f = 1.;
+  for (unsigned int d = 0; d < dim; ++d)
+    f *= std::pow(point[d], poly_degree);
+  return f;
+}
+
+
+
+template <typename CoefficientType>
+void
+  prepare_symmetric_coefficients(Table<1, CoefficientType> &         coeff,
+                                 const std::vector<CoefficientType> &coeff_1d)
+{
+  Assert(coeff.size(0) == coeff_1d.size(), ExcInternalError());
+
+  for (unsigned int i = 0; i < coeff.size(0); ++i)
+    coeff(i) = coeff_1d[i];
+}
+
+template <typename CoefficientType>
+void
+  prepare_symmetric_coefficients(Table<2, CoefficientType> &         coeff,
+                                 const std::vector<CoefficientType> &coeff_1d)
+{
+  for (unsigned int d = 0; d < 2; ++d)
+    Assert(coeff.size(d) == coeff_1d.size(), ExcInternalError());
+
+  for (unsigned int i = 0; i < coeff.size(0); ++i)
+    for (unsigned int j = 0; j < coeff.size(1); ++j)
+      coeff(i, j) = coeff_1d[i] * coeff_1d[j];
+}
+
+template <typename CoefficientType>
+void
+  prepare_symmetric_coefficients(Table<3, CoefficientType> &         coeff,
+                                 const std::vector<CoefficientType> &coeff_1d)
+{
+  for (unsigned int d = 0; d < 3; ++d)
+    Assert(coeff.size(d) == coeff_1d.size(), ExcInternalError());
+
+  for (unsigned int i = 0; i < coeff.size(0); ++i)
+    for (unsigned int j = 0; j < coeff.size(1); ++j)
+      for (unsigned int k = 0; k < coeff.size(2); ++k)
+        coeff(i, j, k) = coeff_1d[i] * coeff_1d[j] * coeff_1d[k];
+}
+
+
+
+template <typename CoefficientType>
+typename CoefficientType::value_type
+compare(const Table<1, CoefficientType> &coeff1,
+        const Table<1, CoefficientType> &coeff2)
+{
+  Assert(coeff1.size(0) == coeff2.size(0), ExcInternalError());
+
+  typename CoefficientType::value_type linf = 0.;
+  for (unsigned int i = 0; i < coeff1.size(0); i++)
+    linf = std::max(linf, std::abs(coeff1(i) - coeff2(i)));
+
+  return linf;
+}
+
+template <typename CoefficientType>
+typename CoefficientType::value_type
+compare(const Table<2, CoefficientType> &coeff1,
+        const Table<2, CoefficientType> &coeff2)
+{
+  for (unsigned int d = 0; d < 2; ++d)
+    Assert(coeff1.size(d) == coeff2.size(d), ExcInternalError());
+
+  typename CoefficientType::value_type linf = 0.;
+  for (unsigned int i = 0; i < coeff1.size(0); i++)
+    for (unsigned int j = 0; j < coeff1.size(1); j++)
+      linf = std::max(linf, std::abs(coeff1(i, j) - coeff2(i, j)));
+
+  return linf;
+}
+
+template <typename CoefficientType>
+typename CoefficientType::value_type
+compare(const Table<3, CoefficientType> &coeff1,
+        const Table<3, CoefficientType> &coeff2)
+{
+  for (unsigned int d = 0; d < 3; ++d)
+    Assert(coeff1.size(d) == coeff2.size(d), ExcInternalError());
+
+  typename CoefficientType::value_type linf = 0.;
+  for (unsigned int i = 0; i < coeff1.size(0); i++)
+    for (unsigned int j = 0; j < coeff1.size(1); j++)
+      for (unsigned int k = 0; k < coeff1.size(2); k++)
+        linf = std::max(linf, std::abs(coeff1(i, j, k) - coeff2(i, j, k)));
+
+  return linf;
+}
+
+
+
+template <int dim>
+void
+test(const unsigned int poly_degree)
+{
+  const unsigned int    max_poly = 3;
+  hp::FECollection<dim> fe_collection;
+  for (unsigned int p = 1; p <= max_poly; ++p)
+    fe_collection.push_back(FE_Q<dim>(p));
+
+  const unsigned int              fe_index = poly_degree - 1;
+  const std::vector<unsigned int> n_coefficients_per_direction =
+    SmoothnessEstimator::Fourier::default_number_of_coefficients_per_direction(
+      fe_collection);
+  const unsigned int n_modes = n_coefficients_per_direction[fe_index];
+
+  Assert((poly_degree >= 1) && (poly_degree <= max_poly), ExcInternalError());
+  Assert((n_modes >= 3) && (n_modes <= max_poly + 1), ExcInternalError());
+
+  deallog << "-----------------------------------" << std::endl;
+  deallog << dim << "d, p=" << poly_degree << ", max_p=" << max_poly
+          << ", n_modes=" << n_modes << std::endl;
+  deallog << "-----------------------------------" << std::endl;
+
+  // --- prepare test function ---
+  PolyFunction<dim> test_function(poly_degree);
+
+  // exact coefficients in 1D case
+  const double &pi  = numbers::PI;
+  const double  pi2 = std::pow(pi, 2);
+  const double  pi3 = std::pow(pi, 3);
+
+  std::vector<std::complex<double>> exact(n_modes);
+  switch (poly_degree)
+    {
+      case 1:
+        exact[0] = std::complex<double>(1., 0.) / 2.;
+        if (n_modes > 1)
+          exact[1] = std::complex<double>(0., -1.) / (2. * pi);
+        if (n_modes > 2)
+          exact[2] = std::complex<double>(0., -1.) / (4. * pi);
+        if (n_modes > 3)
+          exact[3] = std::complex<double>(0., -1.) / (6. * pi);
+        break;
+      case 2:
+        exact[0] = std::complex<double>(1., 0.) / 3.;
+        if (n_modes > 1)
+          exact[1] = std::complex<double>(1., -pi) / (2. * pi2);
+        if (n_modes > 2)
+          exact[2] = std::complex<double>(1., -2. * pi) / (8. * pi2);
+        if (n_modes > 3)
+          exact[3] = std::complex<double>(1., -3. * pi) / (18. * pi2);
+        break;
+      case 3:
+        exact[0] = std::complex<double>(1., 0.) / 4.;
+        if (n_modes > 1)
+          exact[1] = std::complex<double>(3. * pi, 3. - 2. * pi2) / (4. * pi3);
+        if (n_modes > 2)
+          exact[2] = std::complex<double>(6. * pi, 3. - 8. * pi2) / (32. * pi3);
+        if (n_modes > 3)
+          exact[3] = std::complex<double>(3. * pi, 1. - 6. * pi2) / (36. * pi3);
+        break;
+      default:
+        Assert(false, ExcNotImplemented());
+        break;
+    }
+
+  // coefficient table for multi-dimensional case
+  TableIndices<dim> size;
+  for (unsigned int d = 0; d < dim; ++d)
+    size[d] = n_modes;
+  Table<dim, std::complex<double>> coeff_in;
+  coeff_in.reinit(size);
+  prepare_symmetric_coefficients(coeff_in, exact);
+
+
+  // --- prepare data structures ---
+  Triangulation<dim> tria;
+  GridGenerator::hyper_cube(tria, 0.0, 1.0); // reference cell
+
+  hp::DoFHandler<dim> dof_handler(tria);
+  dof_handler.begin_active()->set_active_fe_index(fe_index);
+  dof_handler.distribute_dofs(fe_collection);
+
+
+  // --- calculate coefficients from exact solution ---
+  Vector<double> values(dof_handler.n_dofs());
+  VectorTools::interpolate(dof_handler, test_function, values);
+
+  Vector<double> local_dof_values;
+  auto           cell = dof_handler.begin_active();
+  local_dof_values.reinit(cell->get_fe().dofs_per_cell);
+  cell->get_dof_values(values, local_dof_values);
+
+  hp::QCollection<dim> q_collection =
+    SmoothnessEstimator::Fourier::default_quadrature_collection(fe_collection);
+  FESeries::Fourier<dim> fourier(n_coefficients_per_direction,
+                                 fe_collection,
+                                 q_collection);
+
+  Table<dim, std::complex<double>> coeff_out;
+  coeff_out.reinit(size);
+  fourier.calculate(local_dof_values, cell->active_fe_index(), coeff_out);
+
+  // verify results
+  const double linf = compare(coeff_in, coeff_out);
+  deallog << "Linf norm in exact and calculate Fourier coefficients:"
+          << std::endl
+          << linf << std::endl;
+
+  // finally test smoothness estimator:
+  Vector<float> regularity(1);
+  SmoothnessEstimator::Fourier::coefficient_decay(
+    fourier,
+    dof_handler,
+    values,
+    regularity,
+    /*regression_strategy=*/VectorTools::Linfty_norm,
+    /*smallest_abs_coefficient=*/1e-10,
+    /*only_flagged_cells=*/false);
+
+  deallog << "estimated regularity:" << std::endl << regularity[0] << std::endl;
+
+  dof_handler.clear();
+}
+
+
+
+int
+main()
+{
+  std::ofstream logfile("output");
+  dealii::deallog.attach(logfile, /*do not print job id*/ false);
+  dealii::deallog.depth_console(0);
+
+  for (unsigned int poly_degree = 1; poly_degree <= 3; ++poly_degree)
+    {
+      test<1>(poly_degree);
+      test<2>(poly_degree);
+      test<3>(poly_degree);
+    }
+
+  dealii::deallog << "Ok" << std::endl;
+}
diff --git a/tests/numerics/smoothness_estimator_02.output b/tests/numerics/smoothness_estimator_02.output
new file mode 100644 (file)
index 0000000..ff88be2
--- /dev/null
@@ -0,0 +1,64 @@
+DEAL::-----------------------------------
+DEAL::1d, p=1, max_p=3, n_modes=3
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::0.000831516
+DEAL::estimated regularity:
+DEAL::0.988446
+DEAL::-----------------------------------
+DEAL::2d, p=1, max_p=3, n_modes=3
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::0.000415758
+DEAL::estimated regularity:
+DEAL::1.09966
+DEAL::-----------------------------------
+DEAL::3d, p=1, max_p=3, n_modes=3
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::0.000207879
+DEAL::estimated regularity:
+DEAL::0.890459
+DEAL::-----------------------------------
+DEAL::1d, p=2, max_p=3, n_modes=3
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::0.000637547
+DEAL::estimated regularity:
+DEAL::1.04031
+DEAL::-----------------------------------
+DEAL::2d, p=2, max_p=3, n_modes=3
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::0.000212516
+DEAL::estimated regularity:
+DEAL::0.854283
+DEAL::-----------------------------------
+DEAL::3d, p=2, max_p=3, n_modes=3
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::7.08386e-05
+DEAL::estimated regularity:
+DEAL::0.504717
+DEAL::-----------------------------------
+DEAL::1d, p=3, max_p=3, n_modes=4
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::0.000375709
+DEAL::estimated regularity:
+DEAL::0.972651
+DEAL::-----------------------------------
+DEAL::2d, p=3, max_p=3, n_modes=4
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::9.39272e-05
+DEAL::estimated regularity:
+DEAL::0.522683
+DEAL::-----------------------------------
+DEAL::3d, p=3, max_p=3, n_modes=4
+DEAL::-----------------------------------
+DEAL::Linf norm in exact and calculate Fourier coefficients:
+DEAL::2.34818e-05
+DEAL::estimated regularity:
+DEAL::0.417735
+DEAL::Ok
index 28276e26c46e940c4b8de806b8a9550a05055f23..4a4bc517d3c054802124181ae8b9cb377704d03d 100644 (file)
@@ -32,8 +32,9 @@ void
 test()
 {
   // setup
-  hp::FECollection<dim> hp_fe;
-  hp::QCollection<dim>  hp_q;
+  std::vector<unsigned int> n_modes;
+  hp::FECollection<dim>     hp_fe;
+  hp::QCollection<dim>      hp_q;
 
   const unsigned int   min_degree = 1, max_degree = 2;
   const QGauss<1>      base_quadrature(4);
@@ -41,12 +42,13 @@ test()
   const QSorted<dim>   quadrature_sorted(quadrature);
   for (unsigned int p = min_degree; p <= max_degree; ++p)
     {
+      n_modes.push_back(max_degree + 1);
       hp_fe.push_back(FE_Q<dim>(p));
       hp_q.push_back(quadrature_sorted);
     }
 
-  FESeries::Fourier<dim> fourier_save(max_degree + 1, hp_fe, hp_q);
-  FESeries::Fourier<dim> fourier_load(max_degree + 1, hp_fe, hp_q);
+  FESeries::Fourier<dim> fourier_save(n_modes, hp_fe, hp_q);
+  FESeries::Fourier<dim> fourier_load(n_modes, hp_fe, hp_q);
 
   // create transformation matrices
   fourier_save.precalculate_all_transformation_matrices();
index 39398fe863daf83af32cb18ab669ed02241444f8..571787f90c6ce2b65aec3e72be0d204df5f90769 100644 (file)
@@ -1,7 +1,7 @@
 
-DEAL:1d::3 2 10 FE_Q<1>(1) 10 FE_Q<1>(2) 2 0 0 0 0 0 0 8 0 0 0 0 0 1 0 0 3.47159221014868569e-02 1 4.65284077898513171e-01 1 5.34715922101486885e-01 1 9.65284077898513226e-01 1 1.65004739103785936e-01 1 3.34995260896214064e-01 1 6.65004739103785880e-01 1 8.34995260896214120e-01 8 0 8.69637112843634624e-02 8.69637112843634624e-02 8.69637112843634624e-02 8.69637112843634624e-02 1.63036288715636524e-01 1.63036288715636524e-01 1.63036288715636524e-01 1.63036288715636524e-01 8 0 1 3.47159221014868569e-02 1 4.65284077898513171e-01 1 5.34715922101486885e-01 1 9.65284077898513226e-01 1 1.65004739103785936e-01 1 3.34995260896214064e-01 1 6.65004739103785880e-01 1 8.34995260896214120e-01 8 0 8.69637112843634624e-02 8.69637112843634624e-02 8.69637112843634624e-02 8.69637112843634624e-02 1.63036288715636524e-01 1.63036288715636524e-01 1.63036288715636524e-01 1.63036288715636524e-01 0 0 2 0 0 0 0 0 6 4.99999999999999944e-01 0.00000000000000000e+00 5.00000000000000000e-01 0.00000000000000000e+00 -1.73472347597680709e-18 1.59153688032438484e-01 0.00000000000000000e+00 -1.59153688032438317e-01 5.33917649563659877e-04 8.02149275159986103e-02 5.33917649563897534e-04 -8.02149275159983605e-02 0 0 2 3 2 9 1.66666666666666657e-01 0.00000000000000000e+00 1.66666666666666713e-01 0.00000000000000000e+00 6.66666666666666630e-01 0.00000000000000000e+00 1.01327477769070529e-01 1.59153688032438401e-01 1.01327477769070570e-01 -1.59153688032438401e-01 -2.02654955538141113e-01 1.38777878078144568e-16 2.48179557444021051e-02 8.02149275159984715e-02 2.48179557444023757e-02 -8.02149275159984576e-02 -4.85680761896770119e-02 2.22044604925031308e-16 2 3 3
+DEAL:1d::2 0 3 3 2 10 FE_Q<1>(1) 10 FE_Q<1>(2) 2 0 0 0 0 0 0 8 0 0 0 0 0 1 0 0 3.47159221014868569e-02 1 4.65284077898513171e-01 1 5.34715922101486885e-01 1 9.65284077898513226e-01 1 1.65004739103785936e-01 1 3.34995260896214064e-01 1 6.65004739103785880e-01 1 8.34995260896214120e-01 8 0 8.69637112843634624e-02 8.69637112843634624e-02 8.69637112843634624e-02 8.69637112843634624e-02 1.63036288715636524e-01 1.63036288715636524e-01 1.63036288715636524e-01 1.63036288715636524e-01 8 0 1 3.47159221014868569e-02 1 4.65284077898513171e-01 1 5.34715922101486885e-01 1 9.65284077898513226e-01 1 1.65004739103785936e-01 1 3.34995260896214064e-01 1 6.65004739103785880e-01 1 8.34995260896214120e-01 8 0 8.69637112843634624e-02 8.69637112843634624e-02 8.69637112843634624e-02 8.69637112843634624e-02 1.63036288715636524e-01 1.63036288715636524e-01 1.63036288715636524e-01 1.63036288715636524e-01 0 0 2 0 0 0 0 0 6 4.99999999999999944e-01 0.00000000000000000e+00 5.00000000000000000e-01 0.00000000000000000e+00 -1.73472347597680709e-18 1.59153688032438484e-01 0.00000000000000000e+00 -1.59153688032438317e-01 5.33917649563659877e-04 8.02149275159986103e-02 5.33917649563897534e-04 -8.02149275159983605e-02 0 0 2 3 2 9 1.66666666666666657e-01 0.00000000000000000e+00 1.66666666666666713e-01 0.00000000000000000e+00 6.66666666666666630e-01 0.00000000000000000e+00 1.01327477769070529e-01 1.59153688032438401e-01 1.01327477769070570e-01 -1.59153688032438401e-01 -2.02654955538141113e-01 1.38777878078144568e-16 2.48179557444021051e-02 8.02149275159984715e-02 2.48179557444023757e-02 -8.02149275159984576e-02 -4.85680761896770119e-02 2.22044604925031308e-16 2 3 3
 DEAL:1d::OK
-DEAL:2d::9 2 10 FE_Q<2>(1) 10 FE_Q<2>(2) 2 0 0 0 0 0 0 64 0 0 0 0 0 2 0 0 3.47159221014868569e-02 5.34715922101486885e-01 2 9.65284077898513226e-01 9.65284077898513226e-01 2 5.34715922101486885e-01 9.65284077898513226e-01 2 4.65284077898513171e-01 9.65284077898513226e-01 2 3.47159221014868569e-02 9.65284077898513226e-01 2 9.65284077898513226e-01 5.34715922101486885e-01 2 5.34715922101486885e-01 5.34715922101486885e-01 2 4.65284077898513171e-01 5.34715922101486885e-01 2 3.47159221014868569e-02 3.47159221014868569e-02 2 9.65284077898513226e-01 4.65284077898513171e-01 2 5.34715922101486885e-01 4.65284077898513171e-01 2 4.65284077898513171e-01 4.65284077898513171e-01 2 3.47159221014868569e-02 4.65284077898513171e-01 2 9.65284077898513226e-01 3.47159221014868569e-02 2 4.65284077898513171e-01 3.47159221014868569e-02 2 5.34715922101486885e-01 3.47159221014868569e-02 2 5.34715922101486885e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 3.47159221014868569e-02 2 6.65004739103785880e-01 5.34715922101486885e-01 2 6.65004739103785880e-01 3.47159221014868569e-02 2 3.47159221014868569e-02 6.65004739103785880e-01 2 4.65284077898513171e-01 6.65004739103785880e-01 2 5.34715922101486885e-01 6.65004739103785880e-01 2 9.65284077898513226e-01 6.65004739103785880e-01 2 3.47159221014868569e-02 8.34995260896214120e-01 2 4.65284077898513171e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 5.34715922101486885e-01 2 9.65284077898513226e-01 8.34995260896214120e-01 2 1.65004739103785936e-01 9.65284077898513226e-01 2 3.34995260896214064e-01 9.65284077898513226e-01 2 3.34995260896214064e-01 3.47159221014868569e-02 2 6.65004739103785880e-01 9.65284077898513226e-01 2 8.34995260896214120e-01 9.65284077898513226e-01 2 1.65004739103785936e-01 3.47159221014868569e-02 2 1.65004739103785936e-01 5.34715922101486885e-01 2 9.65284077898513226e-01 3.34995260896214064e-01 2 5.34715922101486885e-01 1.65004739103785936e-01 2 1.65004739103785936e-01 4.65284077898513171e-01 2 3.34995260896214064e-01 4.65284077898513171e-01 2 5.34715922101486885e-01 3.34995260896214064e-01 2 4.65284077898513171e-01 3.34995260896214064e-01 2 4.65284077898513171e-01 1.65004739103785936e-01 2 3.47159221014868569e-02 3.34995260896214064e-01 2 6.65004739103785880e-01 4.65284077898513171e-01 2 8.34995260896214120e-01 4.65284077898513171e-01 2 9.65284077898513226e-01 1.65004739103785936e-01 2 3.34995260896214064e-01 5.34715922101486885e-01 2 3.47159221014868569e-02 1.65004739103785936e-01 2 1.65004739103785936e-01 3.34995260896214064e-01 2 3.34995260896214064e-01 3.34995260896214064e-01 2 6.65004739103785880e-01 3.34995260896214064e-01 2 8.34995260896214120e-01 3.34995260896214064e-01 2 8.34995260896214120e-01 1.65004739103785936e-01 2 8.34995260896214120e-01 8.34995260896214120e-01 2 6.65004739103785880e-01 8.34995260896214120e-01 2 3.34995260896214064e-01 8.34995260896214120e-01 2 1.65004739103785936e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 6.65004739103785880e-01 2 6.65004739103785880e-01 6.65004739103785880e-01 2 3.34995260896214064e-01 1.65004739103785936e-01 2 3.34995260896214064e-01 6.65004739103785880e-01 2 1.65004739103785936e-01 6.65004739103785880e-01 2 6.65004739103785880e-01 1.65004739103785936e-01 2 1.65004739103785936e-01 1.65004739103785936e-01 64 0 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 64 0 2 3.47159221014868569e-02 5.34715922101486885e-01 2 9.65284077898513226e-01 9.65284077898513226e-01 2 5.34715922101486885e-01 9.65284077898513226e-01 2 4.65284077898513171e-01 9.65284077898513226e-01 2 3.47159221014868569e-02 9.65284077898513226e-01 2 9.65284077898513226e-01 5.34715922101486885e-01 2 5.34715922101486885e-01 5.34715922101486885e-01 2 4.65284077898513171e-01 5.34715922101486885e-01 2 3.47159221014868569e-02 3.47159221014868569e-02 2 9.65284077898513226e-01 4.65284077898513171e-01 2 5.34715922101486885e-01 4.65284077898513171e-01 2 4.65284077898513171e-01 4.65284077898513171e-01 2 3.47159221014868569e-02 4.65284077898513171e-01 2 9.65284077898513226e-01 3.47159221014868569e-02 2 4.65284077898513171e-01 3.47159221014868569e-02 2 5.34715922101486885e-01 3.47159221014868569e-02 2 5.34715922101486885e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 3.47159221014868569e-02 2 6.65004739103785880e-01 5.34715922101486885e-01 2 6.65004739103785880e-01 3.47159221014868569e-02 2 3.47159221014868569e-02 6.65004739103785880e-01 2 4.65284077898513171e-01 6.65004739103785880e-01 2 5.34715922101486885e-01 6.65004739103785880e-01 2 9.65284077898513226e-01 6.65004739103785880e-01 2 3.47159221014868569e-02 8.34995260896214120e-01 2 4.65284077898513171e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 5.34715922101486885e-01 2 9.65284077898513226e-01 8.34995260896214120e-01 2 1.65004739103785936e-01 9.65284077898513226e-01 2 3.34995260896214064e-01 9.65284077898513226e-01 2 3.34995260896214064e-01 3.47159221014868569e-02 2 6.65004739103785880e-01 9.65284077898513226e-01 2 8.34995260896214120e-01 9.65284077898513226e-01 2 1.65004739103785936e-01 3.47159221014868569e-02 2 1.65004739103785936e-01 5.34715922101486885e-01 2 9.65284077898513226e-01 3.34995260896214064e-01 2 5.34715922101486885e-01 1.65004739103785936e-01 2 1.65004739103785936e-01 4.65284077898513171e-01 2 3.34995260896214064e-01 4.65284077898513171e-01 2 5.34715922101486885e-01 3.34995260896214064e-01 2 4.65284077898513171e-01 3.34995260896214064e-01 2 4.65284077898513171e-01 1.65004739103785936e-01 2 3.47159221014868569e-02 3.34995260896214064e-01 2 6.65004739103785880e-01 4.65284077898513171e-01 2 8.34995260896214120e-01 4.65284077898513171e-01 2 9.65284077898513226e-01 1.65004739103785936e-01 2 3.34995260896214064e-01 5.34715922101486885e-01 2 3.47159221014868569e-02 1.65004739103785936e-01 2 1.65004739103785936e-01 3.34995260896214064e-01 2 3.34995260896214064e-01 3.34995260896214064e-01 2 6.65004739103785880e-01 3.34995260896214064e-01 2 8.34995260896214120e-01 3.34995260896214064e-01 2 8.34995260896214120e-01 1.65004739103785936e-01 2 8.34995260896214120e-01 8.34995260896214120e-01 2 6.65004739103785880e-01 8.34995260896214120e-01 2 3.34995260896214064e-01 8.34995260896214120e-01 2 1.65004739103785936e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 6.65004739103785880e-01 2 6.65004739103785880e-01 6.65004739103785880e-01 2 3.34995260896214064e-01 1.65004739103785936e-01 2 3.34995260896214064e-01 6.65004739103785880e-01 2 1.65004739103785936e-01 6.65004739103785880e-01 2 6.65004739103785880e-01 1.65004739103785936e-01 2 1.65004739103785936e-01 1.65004739103785936e-01 64 0 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 0 0 2 0 0 0 0 0 36 2.50000000000000056e-01 0.00000000000000000e+00 2.50000000000000000e-01 0.00000000000000000e+00 2.50000000000000056e-01 0.00000000000000000e+00 2.50000000000000111e-01 0.00000000000000000e+00 -1.73472347597680709e-18 7.95768440162192420e-02 -6.28837260041592572e-18 7.95768440162192003e-02 2.38524477946810975e-18 -7.95768440162191448e-02 3.79470760369926552e-19 -7.95768440162191726e-02 2.66958824781818663e-04 4.01074637579992913e-02 2.66958824781794160e-04 4.01074637579992913e-02 2.66958824781957224e-04 -4.01074637579991802e-02 2.66958824781951369e-04 -4.01074637579991872e-02 -1.73472347597680709e-18 7.95768440162192281e-02 -1.08420217248550443e-18 -7.95768440162191587e-02 -5.42101086242752217e-18 7.95768440162192142e-02 3.79470760369926552e-19 -7.95768440162191726e-02 -2.53298964143267441e-02 -1.73472347597680709e-17 2.53298964143267441e-02 1.04083408558608426e-17 2.53298964143267406e-02 1.56125112837912638e-17 -2.53298964143266886e-02 1.86482773667506763e-17 -1.27665015494258845e-02 8.49749630336662978e-05 1.27665015494259279e-02 -8.49749630336797690e-05 1.27665015494258655e-02 8.49749630337201420e-05 -1.27665015494258308e-02 -8.49749630336972517e-05 2.66958824781797846e-04 4.01074637579992982e-02 2.66958824781958958e-04 -4.01074637579991802e-02 2.66958824781809772e-04 4.01074637579992982e-02 2.66958824781954622e-04 -4.01074637579991872e-02 -1.27665015494258828e-02 8.49749630336619610e-05 1.27665015494258620e-02 8.49749630337157645e-05 1.27665015494259279e-02 -8.49749630336918849e-05 -1.27665015494258238e-02 -8.49749630337016021e-05 -6.43414952834035422e-03 8.56563311185179477e-05 6.43471966445343171e-03 8.67361737988403547e-18 6.43471966445342478e-03 1.21430643318376497e-17 -6.43414952834028744e-03 -8.56563311185964439e-05 0 0 2 9 4 81 2.77777777777777832e-02 0.00000000000000000e+00 2.77777777777777936e-02 0.00000000000000000e+00 2.77777777777777797e-02 0.00000000000000000e+00 2.77777777777777832e-02 0.00000000000000000e+00 1.11111111111111133e-01 0.00000000000000000e+00 1.11111111111111160e-01 0.00000000000000000e+00 1.11111111111111147e-01 0.00000000000000000e+00 1.11111111111111147e-01 0.00000000000000000e+00 4.44444444444444531e-01 0.00000000000000000e+00 1.68879129615117640e-02 2.65256146720730598e-02 1.68879129615117536e-02 2.65256146720730737e-02 1.68879129615117571e-02 -2.65256146720730807e-02 1.68879129615117675e-02 -2.65256146720730702e-02 -3.37758259230235142e-02 2.16840434497100887e-17 -3.37758259230235211e-02 2.10335221462187860e-17 6.75516518460470561e-02 1.06102458688292267e-01 6.75516518460470700e-02 -1.06102458688292239e-01 -1.35103303692094057e-01 7.63278329429795122e-17 4.13632595740035577e-03 1.33691545859997499e-02 4.13632595740034709e-03 1.33691545859997481e-02 4.13632595740039567e-03 -1.33691545859997429e-02 4.13632595740039133e-03 -1.33691545859997447e-02 -8.09467936494616576e-03 3.55618312575245454e-17 -8.09467936494617096e-03 2.97071395261028215e-17 1.65453038296014439e-02 5.34766183439990064e-02 1.65453038296015965e-02 -5.34766183439989579e-02 -3.23787174597846214e-02 1.35308431126190953e-16 1.68879129615117571e-02 2.65256146720730598e-02 1.68879129615117606e-02 -2.65256146720730633e-02 1.68879129615117571e-02 2.65256146720730737e-02 1.68879129615117606e-02 -2.65256146720730841e-02 6.75516518460470422e-02 1.06102458688292267e-01 6.75516518460470700e-02 -1.06102458688292225e-01 -3.37758259230235211e-02 1.82145964977564745e-17 -3.37758259230235072e-02 1.92987986702419789e-17 -1.35103303692094057e-01 7.28583859910258980e-17 -1.50626386632852528e-02 3.22532835719449990e-02 3.55971541653682319e-02 1.25767452008318514e-17 3.55971541653682388e-02 1.19262238973405488e-17 -1.50626386632852268e-02 -3.22532835719449920e-02 -2.05345155020829860e-02 -3.22532835719449851e-02 -2.05345155020829687e-02 3.22532835719450059e-02 -2.05345155020829895e-02 -3.22532835719449781e-02 -2.05345155020829583e-02 3.22532835719450059e-02 4.10690310041659928e-02 -5.55111512312578270e-17 -1.02517606904612008e-02 1.20778454707723762e-02 1.52812424083905649e-02 4.17810709847750514e-03 1.52812424083905805e-02 -4.17810709847746438e-03 -1.02517606904611557e-02 -1.20778454707724248e-02 -4.92128066039605044e-03 -7.72978844622751980e-03 -4.92128066039596024e-03 7.72978844622755883e-03 -5.02948171792936063e-03 -1.62559525692498909e-02 -5.02948171792941962e-03 1.62559525692499221e-02 9.84256132079208354e-03 -5.72458747072346341e-17 4.13632595740035230e-03 1.33691545859997429e-02 4.13632595740039306e-03 -1.33691545859997412e-02 4.13632595740034883e-03 1.33691545859997499e-02 4.13632595740039133e-03 -1.33691545859997499e-02 1.65453038296014196e-02 5.34766183439989995e-02 1.65453038296015965e-02 -5.34766183439989648e-02 -8.09467936494616576e-03 2.68882138776405100e-17 -8.09467936494617096e-03 3.53449908230274445e-17 -3.23787174597846422e-02 1.40512601554121375e-16 -1.02517606904612025e-02 1.20778454707723779e-02 1.52812424083905874e-02 -4.17810709847746698e-03 1.52812424083905666e-02 4.17810709847750254e-03 -1.02517606904611557e-02 -1.20778454707724300e-02 -5.02948171792935717e-03 -1.62559525692498839e-02 -5.02948171792942655e-03 1.62559525692499082e-02 -4.92128066039605738e-03 -7.72978844622751980e-03 -4.92128066039596197e-03 7.72978844622756057e-03 9.84256132079207660e-03 -6.76542155630954767e-17 -5.81850366906578459e-03 3.98154104226495619e-03 7.05036552372799701e-03 2.66713734431434091e-17 7.05036552372799268e-03 2.68882138776405100e-17 -5.81850366906574989e-03 -3.98154104226500997e-03 -1.20536036546616508e-03 -3.89588471114642133e-03 -1.20536036546611629e-03 3.89588471114642784e-03 -1.20536036546616682e-03 -3.89588471114642350e-03 -1.20536036546611326e-03 3.89588471114642263e-03 2.35885802476632194e-03 -4.33680868994201774e-17 2 9 9
+DEAL:2d::2 0 3 3 2 10 FE_Q<2>(1) 10 FE_Q<2>(2) 2 0 0 0 0 0 0 64 0 0 0 0 0 2 0 0 3.47159221014868569e-02 5.34715922101486885e-01 2 9.65284077898513226e-01 9.65284077898513226e-01 2 5.34715922101486885e-01 9.65284077898513226e-01 2 4.65284077898513171e-01 9.65284077898513226e-01 2 3.47159221014868569e-02 9.65284077898513226e-01 2 9.65284077898513226e-01 5.34715922101486885e-01 2 5.34715922101486885e-01 5.34715922101486885e-01 2 4.65284077898513171e-01 5.34715922101486885e-01 2 3.47159221014868569e-02 3.47159221014868569e-02 2 9.65284077898513226e-01 4.65284077898513171e-01 2 5.34715922101486885e-01 4.65284077898513171e-01 2 4.65284077898513171e-01 4.65284077898513171e-01 2 3.47159221014868569e-02 4.65284077898513171e-01 2 9.65284077898513226e-01 3.47159221014868569e-02 2 4.65284077898513171e-01 3.47159221014868569e-02 2 5.34715922101486885e-01 3.47159221014868569e-02 2 5.34715922101486885e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 3.47159221014868569e-02 2 6.65004739103785880e-01 5.34715922101486885e-01 2 6.65004739103785880e-01 3.47159221014868569e-02 2 3.47159221014868569e-02 6.65004739103785880e-01 2 4.65284077898513171e-01 6.65004739103785880e-01 2 5.34715922101486885e-01 6.65004739103785880e-01 2 9.65284077898513226e-01 6.65004739103785880e-01 2 3.47159221014868569e-02 8.34995260896214120e-01 2 4.65284077898513171e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 5.34715922101486885e-01 2 9.65284077898513226e-01 8.34995260896214120e-01 2 1.65004739103785936e-01 9.65284077898513226e-01 2 3.34995260896214064e-01 9.65284077898513226e-01 2 3.34995260896214064e-01 3.47159221014868569e-02 2 6.65004739103785880e-01 9.65284077898513226e-01 2 8.34995260896214120e-01 9.65284077898513226e-01 2 1.65004739103785936e-01 3.47159221014868569e-02 2 1.65004739103785936e-01 5.34715922101486885e-01 2 9.65284077898513226e-01 3.34995260896214064e-01 2 5.34715922101486885e-01 1.65004739103785936e-01 2 1.65004739103785936e-01 4.65284077898513171e-01 2 3.34995260896214064e-01 4.65284077898513171e-01 2 5.34715922101486885e-01 3.34995260896214064e-01 2 4.65284077898513171e-01 3.34995260896214064e-01 2 4.65284077898513171e-01 1.65004739103785936e-01 2 3.47159221014868569e-02 3.34995260896214064e-01 2 6.65004739103785880e-01 4.65284077898513171e-01 2 8.34995260896214120e-01 4.65284077898513171e-01 2 9.65284077898513226e-01 1.65004739103785936e-01 2 3.34995260896214064e-01 5.34715922101486885e-01 2 3.47159221014868569e-02 1.65004739103785936e-01 2 1.65004739103785936e-01 3.34995260896214064e-01 2 3.34995260896214064e-01 3.34995260896214064e-01 2 6.65004739103785880e-01 3.34995260896214064e-01 2 8.34995260896214120e-01 3.34995260896214064e-01 2 8.34995260896214120e-01 1.65004739103785936e-01 2 8.34995260896214120e-01 8.34995260896214120e-01 2 6.65004739103785880e-01 8.34995260896214120e-01 2 3.34995260896214064e-01 8.34995260896214120e-01 2 1.65004739103785936e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 6.65004739103785880e-01 2 6.65004739103785880e-01 6.65004739103785880e-01 2 3.34995260896214064e-01 1.65004739103785936e-01 2 3.34995260896214064e-01 6.65004739103785880e-01 2 1.65004739103785936e-01 6.65004739103785880e-01 2 6.65004739103785880e-01 1.65004739103785936e-01 2 1.65004739103785936e-01 1.65004739103785936e-01 64 0 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 64 0 2 3.47159221014868569e-02 5.34715922101486885e-01 2 9.65284077898513226e-01 9.65284077898513226e-01 2 5.34715922101486885e-01 9.65284077898513226e-01 2 4.65284077898513171e-01 9.65284077898513226e-01 2 3.47159221014868569e-02 9.65284077898513226e-01 2 9.65284077898513226e-01 5.34715922101486885e-01 2 5.34715922101486885e-01 5.34715922101486885e-01 2 4.65284077898513171e-01 5.34715922101486885e-01 2 3.47159221014868569e-02 3.47159221014868569e-02 2 9.65284077898513226e-01 4.65284077898513171e-01 2 5.34715922101486885e-01 4.65284077898513171e-01 2 4.65284077898513171e-01 4.65284077898513171e-01 2 3.47159221014868569e-02 4.65284077898513171e-01 2 9.65284077898513226e-01 3.47159221014868569e-02 2 4.65284077898513171e-01 3.47159221014868569e-02 2 5.34715922101486885e-01 3.47159221014868569e-02 2 5.34715922101486885e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 3.47159221014868569e-02 2 6.65004739103785880e-01 5.34715922101486885e-01 2 6.65004739103785880e-01 3.47159221014868569e-02 2 3.47159221014868569e-02 6.65004739103785880e-01 2 4.65284077898513171e-01 6.65004739103785880e-01 2 5.34715922101486885e-01 6.65004739103785880e-01 2 9.65284077898513226e-01 6.65004739103785880e-01 2 3.47159221014868569e-02 8.34995260896214120e-01 2 4.65284077898513171e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 5.34715922101486885e-01 2 9.65284077898513226e-01 8.34995260896214120e-01 2 1.65004739103785936e-01 9.65284077898513226e-01 2 3.34995260896214064e-01 9.65284077898513226e-01 2 3.34995260896214064e-01 3.47159221014868569e-02 2 6.65004739103785880e-01 9.65284077898513226e-01 2 8.34995260896214120e-01 9.65284077898513226e-01 2 1.65004739103785936e-01 3.47159221014868569e-02 2 1.65004739103785936e-01 5.34715922101486885e-01 2 9.65284077898513226e-01 3.34995260896214064e-01 2 5.34715922101486885e-01 1.65004739103785936e-01 2 1.65004739103785936e-01 4.65284077898513171e-01 2 3.34995260896214064e-01 4.65284077898513171e-01 2 5.34715922101486885e-01 3.34995260896214064e-01 2 4.65284077898513171e-01 3.34995260896214064e-01 2 4.65284077898513171e-01 1.65004739103785936e-01 2 3.47159221014868569e-02 3.34995260896214064e-01 2 6.65004739103785880e-01 4.65284077898513171e-01 2 8.34995260896214120e-01 4.65284077898513171e-01 2 9.65284077898513226e-01 1.65004739103785936e-01 2 3.34995260896214064e-01 5.34715922101486885e-01 2 3.47159221014868569e-02 1.65004739103785936e-01 2 1.65004739103785936e-01 3.34995260896214064e-01 2 3.34995260896214064e-01 3.34995260896214064e-01 2 6.65004739103785880e-01 3.34995260896214064e-01 2 8.34995260896214120e-01 3.34995260896214064e-01 2 8.34995260896214120e-01 1.65004739103785936e-01 2 8.34995260896214120e-01 8.34995260896214120e-01 2 6.65004739103785880e-01 8.34995260896214120e-01 2 3.34995260896214064e-01 8.34995260896214120e-01 2 1.65004739103785936e-01 8.34995260896214120e-01 2 8.34995260896214120e-01 6.65004739103785880e-01 2 6.65004739103785880e-01 6.65004739103785880e-01 2 3.34995260896214064e-01 1.65004739103785936e-01 2 3.34995260896214064e-01 6.65004739103785880e-01 2 1.65004739103785936e-01 6.65004739103785880e-01 2 6.65004739103785880e-01 1.65004739103785936e-01 2 1.65004739103785936e-01 1.65004739103785936e-01 64 0 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 7.56268708035012522e-03 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 1.41782407407407395e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 2.65808314381683897e-02 0 0 2 0 0 0 0 0 36 2.50000000000000056e-01 0.00000000000000000e+00 2.50000000000000000e-01 0.00000000000000000e+00 2.50000000000000056e-01 0.00000000000000000e+00 2.50000000000000111e-01 0.00000000000000000e+00 -1.73472347597680709e-18 7.95768440162192420e-02 -6.28837260041592572e-18 7.95768440162192003e-02 2.38524477946810975e-18 -7.95768440162191448e-02 3.79470760369926552e-19 -7.95768440162191726e-02 2.66958824781818663e-04 4.01074637579992913e-02 2.66958824781794160e-04 4.01074637579992913e-02 2.66958824781957224e-04 -4.01074637579991802e-02 2.66958824781951369e-04 -4.01074637579991872e-02 -1.73472347597680709e-18 7.95768440162192281e-02 -1.08420217248550443e-18 -7.95768440162191587e-02 -5.42101086242752217e-18 7.95768440162192142e-02 3.79470760369926552e-19 -7.95768440162191726e-02 -2.53298964143267441e-02 -1.73472347597680709e-17 2.53298964143267441e-02 1.04083408558608426e-17 2.53298964143267406e-02 1.56125112837912638e-17 -2.53298964143266886e-02 1.86482773667506763e-17 -1.27665015494258845e-02 8.49749630336662978e-05 1.27665015494259279e-02 -8.49749630336797690e-05 1.27665015494258655e-02 8.49749630337201420e-05 -1.27665015494258308e-02 -8.49749630336972517e-05 2.66958824781797846e-04 4.01074637579992982e-02 2.66958824781958958e-04 -4.01074637579991802e-02 2.66958824781809772e-04 4.01074637579992982e-02 2.66958824781954622e-04 -4.01074637579991872e-02 -1.27665015494258828e-02 8.49749630336619610e-05 1.27665015494258620e-02 8.49749630337157645e-05 1.27665015494259279e-02 -8.49749630336918849e-05 -1.27665015494258238e-02 -8.49749630337016021e-05 -6.43414952834035422e-03 8.56563311185179477e-05 6.43471966445343171e-03 8.67361737988403547e-18 6.43471966445342478e-03 1.21430643318376497e-17 -6.43414952834028744e-03 -8.56563311185964439e-05 0 0 2 9 4 81 2.77777777777777832e-02 0.00000000000000000e+00 2.77777777777777936e-02 0.00000000000000000e+00 2.77777777777777797e-02 0.00000000000000000e+00 2.77777777777777832e-02 0.00000000000000000e+00 1.11111111111111133e-01 0.00000000000000000e+00 1.11111111111111160e-01 0.00000000000000000e+00 1.11111111111111147e-01 0.00000000000000000e+00 1.11111111111111147e-01 0.00000000000000000e+00 4.44444444444444531e-01 0.00000000000000000e+00 1.68879129615117640e-02 2.65256146720730598e-02 1.68879129615117536e-02 2.65256146720730737e-02 1.68879129615117571e-02 -2.65256146720730807e-02 1.68879129615117675e-02 -2.65256146720730702e-02 -3.37758259230235142e-02 2.16840434497100887e-17 -3.37758259230235211e-02 2.10335221462187860e-17 6.75516518460470561e-02 1.06102458688292267e-01 6.75516518460470700e-02 -1.06102458688292239e-01 -1.35103303692094057e-01 7.63278329429795122e-17 4.13632595740035577e-03 1.33691545859997499e-02 4.13632595740034709e-03 1.33691545859997481e-02 4.13632595740039567e-03 -1.33691545859997429e-02 4.13632595740039133e-03 -1.33691545859997447e-02 -8.09467936494616576e-03 3.55618312575245454e-17 -8.09467936494617096e-03 2.97071395261028215e-17 1.65453038296014439e-02 5.34766183439990064e-02 1.65453038296015965e-02 -5.34766183439989579e-02 -3.23787174597846214e-02 1.35308431126190953e-16 1.68879129615117571e-02 2.65256146720730598e-02 1.68879129615117606e-02 -2.65256146720730633e-02 1.68879129615117571e-02 2.65256146720730737e-02 1.68879129615117606e-02 -2.65256146720730841e-02 6.75516518460470422e-02 1.06102458688292267e-01 6.75516518460470700e-02 -1.06102458688292225e-01 -3.37758259230235211e-02 1.82145964977564745e-17 -3.37758259230235072e-02 1.92987986702419789e-17 -1.35103303692094057e-01 7.28583859910258980e-17 -1.50626386632852528e-02 3.22532835719449990e-02 3.55971541653682319e-02 1.25767452008318514e-17 3.55971541653682388e-02 1.19262238973405488e-17 -1.50626386632852268e-02 -3.22532835719449920e-02 -2.05345155020829860e-02 -3.22532835719449851e-02 -2.05345155020829687e-02 3.22532835719450059e-02 -2.05345155020829895e-02 -3.22532835719449781e-02 -2.05345155020829583e-02 3.22532835719450059e-02 4.10690310041659928e-02 -5.55111512312578270e-17 -1.02517606904612008e-02 1.20778454707723762e-02 1.52812424083905649e-02 4.17810709847750514e-03 1.52812424083905805e-02 -4.17810709847746438e-03 -1.02517606904611557e-02 -1.20778454707724248e-02 -4.92128066039605044e-03 -7.72978844622751980e-03 -4.92128066039596024e-03 7.72978844622755883e-03 -5.02948171792936063e-03 -1.62559525692498909e-02 -5.02948171792941962e-03 1.62559525692499221e-02 9.84256132079208354e-03 -5.72458747072346341e-17 4.13632595740035230e-03 1.33691545859997429e-02 4.13632595740039306e-03 -1.33691545859997412e-02 4.13632595740034883e-03 1.33691545859997499e-02 4.13632595740039133e-03 -1.33691545859997499e-02 1.65453038296014196e-02 5.34766183439989995e-02 1.65453038296015965e-02 -5.34766183439989648e-02 -8.09467936494616576e-03 2.68882138776405100e-17 -8.09467936494617096e-03 3.53449908230274445e-17 -3.23787174597846422e-02 1.40512601554121375e-16 -1.02517606904612025e-02 1.20778454707723779e-02 1.52812424083905874e-02 -4.17810709847746698e-03 1.52812424083905666e-02 4.17810709847750254e-03 -1.02517606904611557e-02 -1.20778454707724300e-02 -5.02948171792935717e-03 -1.62559525692498839e-02 -5.02948171792942655e-03 1.62559525692499082e-02 -4.92128066039605738e-03 -7.72978844622751980e-03 -4.92128066039596197e-03 7.72978844622756057e-03 9.84256132079207660e-03 -6.76542155630954767e-17 -5.81850366906578459e-03 3.98154104226495619e-03 7.05036552372799701e-03 2.66713734431434091e-17 7.05036552372799268e-03 2.68882138776405100e-17 -5.81850366906574989e-03 -3.98154104226500997e-03 -1.20536036546616508e-03 -3.89588471114642133e-03 -1.20536036546611629e-03 3.89588471114642784e-03 -1.20536036546616682e-03 -3.89588471114642350e-03 -1.20536036546611326e-03 3.89588471114642263e-03 2.35885802476632194e-03 -4.33680868994201774e-17 2 9 9
 DEAL:2d::OK
-DEAL:3d::27 2 10 FE_Q<3>(1) 10 FE_Q<3>(2) 2 0 0 0 0 0 0 512 0 0 0 0 0 3 0 0 3.47159221014868569e-02 5.34715922101486885e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 4.65284077898513171e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 9.65284077898513226e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 9.65284077898513226e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 4.65284077898513171e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 3.47159221014868569e-02 5.34715922101486885e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 4.65284077898513171e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 8.34995260896214120e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 8.34995260896214120e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 6.65004739103785880e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 3.34995260896214064e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 1.65004739103785936e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 3.34995260896214064e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 3.34995260896214064e-01 512 0 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 512 0 3 3.47159221014868569e-02 5.34715922101486885e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 4.65284077898513171e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 9.65284077898513226e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 9.65284077898513226e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 4.65284077898513171e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 3.47159221014868569e-02 5.34715922101486885e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 4.65284077898513171e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 8.34995260896214120e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 8.34995260896214120e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 6.65004739103785880e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 3.34995260896214064e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 1.65004739103785936e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 3.34995260896214064e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 3.34995260896214064e-01 512 0 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 0 0 2 0 0 0 0 0 216 1.24999999999999944e-01 0.00000000000000000e+00 1.24999999999999972e-01 0.00000000000000000e+00 1.24999999999999972e-01 0.00000000000000000e+00 1.24999999999999958e-01 0.00000000000000000e+00 1.24999999999999931e-01 0.00000000000000000e+00 1.24999999999999986e-01 0.00000000000000000e+00 1.24999999999999972e-01 0.00000000000000000e+00 1.25000000000000000e-01 0.00000000000000000e+00 -3.52365706057788941e-19 3.97884220081096279e-02 -2.27682456221955931e-18 3.97884220081096210e-02 -4.17417836406919207e-18 3.97884220081096279e-02 1.08420217248550443e-18 3.97884220081096626e-02 -9.39190131915568216e-18 -3.97884220081095655e-02 -2.43945488809238498e-18 -3.97884220081095794e-02 6.53231808922516421e-18 -3.97884220081095863e-02 6.58652819784943944e-18 -3.97884220081095932e-02 1.33479412390903504e-04 2.00537318789996422e-02 1.33479412390905211e-04 2.00537318789996595e-02 1.33479412390908789e-04 2.00537318789996456e-02 1.33479412390904181e-04 2.00537318789996491e-02 1.33479412391012331e-04 -2.00537318789995866e-02 1.33479412391013469e-04 -2.00537318789995832e-02 1.33479412390986743e-04 -2.00537318789995762e-02 1.33479412391004199e-04 -2.00537318789995901e-02 -6.23416249179165050e-19 3.97884220081096626e-02 -1.51788304147970621e-18 3.97884220081096487e-02 4.06575814682064163e-19 -3.97884220081095932e-02 2.33103467084383453e-18 -3.97884220081096002e-02 6.91178884959509077e-19 3.97884220081096071e-02 2.05998412772245842e-18 3.97884220081096487e-02 1.54498809579184382e-18 -3.97884220081096210e-02 -1.19262238973405488e-18 -3.97884220081096140e-02 -1.26649482071633651e-02 -3.08997619158368764e-18 -1.26649482071633703e-02 -3.25260651745651330e-18 1.26649482071633738e-02 1.13841228110977966e-18 1.26649482071633651e-02 6.83047368665867793e-18 1.26649482071633790e-02 3.55076211489002702e-18 1.26649482071633738e-02 1.73472347597680709e-18 -1.26649482071633634e-02 4.97377746627725159e-18 -1.26649482071633564e-02 8.89045781438113636e-18 -6.38325077471294574e-03 4.24874815168267656e-05 -6.38325077471294921e-03 4.24874815168262710e-05 6.38325077471295962e-03 -4.24874815168392678e-05 6.38325077471296222e-03 -4.24874815168380549e-05 6.38325077471293533e-03 4.24874815168508417e-05 6.38325077471293013e-03 4.24874815168537894e-05 -6.38325077471290931e-03 -4.24874815168442281e-05 -6.38325077471291365e-03 -4.24874815168452513e-05 1.33479412390940909e-04 2.00537318789996595e-02 1.33479412390939472e-04 2.00537318789996560e-02 1.33479412390981106e-04 -2.00537318789995971e-02 1.33479412391005012e-04 -2.00537318789996005e-02 1.33479412390913018e-04 2.00537318789996560e-02 1.33479412390898110e-04 2.00537318789996560e-02 1.33479412390967119e-04 -2.00537318789995866e-02 1.33479412390963325e-04 -2.00537318789995866e-02 -6.38325077471294400e-03 4.24874815168262506e-05 -6.38325077471294054e-03 4.24874815168263658e-05 6.38325077471293360e-03 4.24874815168628492e-05 6.38325077471293880e-03 4.24874815168620835e-05 6.38325077471296656e-03 -4.24874815168440383e-05 6.38325077471296048e-03 -4.24874815168451293e-05 -6.38325077471290497e-03 -4.24874815168387935e-05 -6.38325077471290758e-03 -4.24874815168570826e-05 -3.21707476417017711e-03 4.28281655592655333e-05 -3.21707476417018145e-03 4.28281655592529023e-05 3.21735983222671195e-03 1.10859672136642828e-17 3.21735983222671369e-03 9.43255890062388858e-18 3.21735983222670935e-03 8.48388199969907220e-18 3.21735983222671109e-03 9.10729824887823725e-18 -3.21707476417013504e-03 -4.28281655592915541e-05 -3.21707476417013982e-03 -4.28281655592949694e-05 -3.17129135452010047e-18 3.97884220081096140e-02 -2.16840434497100887e-19 -3.97884220081096002e-02 -3.87602276663567835e-18 3.97884220081096349e-02 -5.96311194867027439e-19 -3.97884220081096140e-02 -2.98155597433513719e-18 3.97884220081096279e-02 7.04731412115577882e-19 -3.97884220081096002e-02 -1.49755425074560300e-18 3.97884220081096557e-02 1.89735380184963276e-18 -3.97884220081096140e-02 -1.26649482071633703e-02 -5.14996031930614606e-18 1.26649482071633721e-02 1.73472347597680709e-18 -1.26649482071633721e-02 -2.76471553983803631e-18 1.26649482071633686e-02 3.57786716920216463e-18 1.26649482071633755e-02 7.56231015308639343e-18 -1.26649482071633426e-02 1.17093834628434479e-17 1.26649482071633738e-02 6.32903018188413213e-18 -1.26649482071633495e-02 4.44522890719056818e-18 -6.38325077471294487e-03 4.24874815168318072e-05 6.38325077471295702e-03 -4.24874815168347277e-05 -6.38325077471294574e-03 4.24874815168295304e-05 6.38325077471295702e-03 -4.24874815168399522e-05 6.38325077471293360e-03 4.24874815168548600e-05 -6.38325077471291278e-03 -4.24874815168488020e-05 6.38325077471293620e-03 4.24874815168627205e-05 -6.38325077471291365e-03 -4.24874815168433065e-05 -1.26649482071633668e-02 -6.17995238316737527e-18 1.26649482071633703e-02 4.55364912443911862e-18 1.26649482071633703e-02 3.79470760369926552e-18 -1.26649482071633426e-02 8.34835672813838414e-18 -1.26649482071633703e-02 -5.88179678573386155e-18 1.26649482071633703e-02 5.42101086242752217e-18 1.26649482071633703e-02 4.16062583691312327e-18 -1.26649482071633391e-02 7.42678488152570537e-18 4.60785923306339384e-18 -4.03134643181973697e-03 4.55364912443911862e-18 4.03134643181974391e-03 5.25838053655469650e-18 4.03134643181974391e-03 3.14418630020796286e-18 -4.03134643181972396e-03 2.71050543121376109e-19 4.03134643181973784e-03 6.07153216591882483e-18 -4.03134643181973611e-03 8.93111539584934278e-18 -4.03134643181974218e-03 1.31188462870746037e-17 4.03134643181971442e-03 -1.35240787572204731e-05 -2.03183580486297494e-03 1.35240787572288215e-05 2.03183580486297408e-03 1.35240787572314913e-05 2.03183580486296757e-03 -1.35240787572172205e-05 -2.03183580486297147e-03 -1.35240787572360450e-05 2.03183580486296497e-03 1.35240787572351640e-05 -2.03183580486296800e-03 1.35240787572377187e-05 -2.03183580486296887e-03 -1.35240787572207170e-05 2.03183580486296063e-03 -6.38325077471293967e-03 4.24874815168312786e-05 6.38325077471296222e-03 -4.24874815168388748e-05 6.38325077471293793e-03 4.24874815168587225e-05 -6.38325077471290758e-03 -4.24874815168442755e-05 -6.38325077471294140e-03 4.24874815168333251e-05 6.38325077471295875e-03 -4.24874815168449396e-05 6.38325077471293186e-03 4.24874815168554157e-05 -6.38325077471291278e-03 -4.24874815168447363e-05 -1.35240787572288757e-05 -2.03183580486297017e-03 1.35240787572314235e-05 2.03183580486297755e-03 -1.35240787572409645e-05 2.03183580486297061e-03 1.35240787572272494e-05 -2.03183580486296280e-03 1.35240787572293229e-05 2.03183580486297017e-03 -1.35240787572236715e-05 -2.03183580486298102e-03 1.35240787572404360e-05 -2.03183580486296454e-03 -1.35240787572284691e-05 2.03183580486295369e-03 -1.36325210008431293e-05 -1.02401862678754940e-03 1.36325210008386840e-05 1.02401862678754875e-03 -1.70761842166466948e-17 1.02410936605261860e-03 -1.52872506320456125e-17 -1.02410936605260841e-03 -1.88786703284038460e-17 1.02410936605261751e-03 -1.26309553094561267e-17 -1.02410936605261513e-03 1.36325210008242235e-05 -1.02401862678754094e-03 -1.36325210008743001e-05 1.02401862678753661e-03 1.33479412390941505e-04 2.00537318789996526e-02 1.33479412391000838e-04 -2.00537318789995797e-02 1.33479412390937358e-04 2.00537318789996595e-02 1.33479412390989725e-04 -2.00537318789995936e-02 1.33479412390902392e-04 2.00537318789996630e-02 1.33479412390965114e-04 -2.00537318789996075e-02 1.33479412390927980e-04 2.00537318789996595e-02 1.33479412390968095e-04 -2.00537318789995936e-02 -6.38325077471294400e-03 4.24874815168320782e-05 6.38325077471293273e-03 4.24874815168582346e-05 -6.38325077471294140e-03 4.24874815168347277e-05 6.38325077471293967e-03 4.24874815168520953e-05 6.38325077471295788e-03 -4.24874815168398913e-05 -6.38325077471291191e-03 -4.24874815168447363e-05 6.38325077471295528e-03 -4.24874815168428728e-05 -6.38325077471290844e-03 -4.24874815168436792e-05 -3.21707476417017451e-03 4.28281655592584317e-05 3.21735983222670892e-03 7.15573433840432926e-18 -3.21707476417017928e-03 4.28281655592480776e-05 3.21735983222671065e-03 8.67361737988403547e-18 3.21735983222670675e-03 8.56519716263548503e-18 -3.21707476417014762e-03 -4.28281655592988725e-05 3.21735983222670328e-03 1.01643953670516041e-17 -3.21707476417014979e-03 -4.28281655592971378e-05 -6.38325077471294227e-03 4.24874815168299708e-05 6.38325077471293099e-03 4.24874815168658444e-05 6.38325077471296048e-03 -4.24874815168242178e-05 -6.38325077471291451e-03 -4.24874815168421478e-05 -6.38325077471293793e-03 4.24874815168316242e-05 6.38325077471293620e-03 4.24874815168549007e-05 6.38325077471295875e-03 -4.24874815168345787e-05 -6.38325077471291105e-03 -4.24874815168555377e-05 -1.35240787572247286e-05 -2.03183580486296844e-03 -1.35240787572397719e-05 2.03183580486297191e-03 1.35240787572300276e-05 2.03183580486298188e-03 1.35240787572288757e-05 -2.03183580486296063e-03 1.35240787572286588e-05 2.03183580486296714e-03 1.35240787572368446e-05 -2.03183580486296627e-03 -1.35240787572270393e-05 -2.03183580486297885e-03 -1.35240787572288486e-05 2.03183580486295586e-03 -1.36325210008455416e-05 -1.02401862678754398e-03 -1.66967134562767683e-17 1.02410936605261708e-03 1.36325210008310675e-05 1.02401862678754983e-03 -1.51246203061727869e-17 -1.02410936605260515e-03 -1.47587020729589291e-17 1.02410936605262055e-03 1.36325210008246978e-05 -1.02401862678754051e-03 -1.22176032311960281e-17 -1.02410936605261817e-03 -1.36325210008754385e-05 1.02401862678754051e-03 -3.21707476417018405e-03 4.28281655592567512e-05 3.21735983222670979e-03 7.15573433840432926e-18 3.21735983222671152e-03 8.91756286869327397e-18 -3.21707476417014459e-03 -4.28281655592897652e-05 -3.21707476417018102e-03 4.28281655592612507e-05 3.21735983222671629e-03 9.10729824887823725e-18 3.21735983222671326e-03 9.08019319456609963e-18 -3.21707476417014415e-03 -4.28281655592982220e-05 -1.36325210008476558e-05 -1.02401862678754094e-03 -1.21430643318376497e-17 1.02410936605261188e-03 -1.26309553094561267e-17 1.02410936605261058e-03 1.36325210008334799e-05 -1.02401862678754138e-03 1.36325210008411641e-05 1.02401862678754094e-03 3.25260651745651330e-19 -1.02410936605262706e-03 2.20228566286118088e-18 -1.02410936605262597e-03 -1.36325210008537815e-05 1.02401862678752642e-03 -1.03062223850791212e-05 -5.16069104615940878e-04 3.43561039885253994e-06 5.16160571469903725e-04 3.43561039884451684e-06 5.16160571469901665e-04 3.43561039885004627e-06 -5.16160571469894617e-04 3.43561039886246039e-06 5.16160571469894184e-04 3.43561039887639239e-06 -5.16160571469919771e-04 3.43561039888150169e-06 -5.16160571469918036e-04 -1.03062223850500104e-05 5.16069104615923206e-04 0 0 2 27 8 729 4.62962962962963458e-03 0.00000000000000000e+00 4.62962962962963284e-03 0.00000000000000000e+00 4.62962962962963284e-03 0.00000000000000000e+00 4.62962962962963718e-03 0.00000000000000000e+00 4.62962962962963197e-03 0.00000000000000000e+00 4.62962962962963891e-03 0.00000000000000000e+00 4.62962962962963631e-03 0.00000000000000000e+00 4.62962962962963978e-03 0.00000000000000000e+00 1.85185185185185106e-02 0.00000000000000000e+00 1.85185185185185244e-02 0.00000000000000000e+00 1.85185185185185175e-02 0.00000000000000000e+00 1.85185185185185210e-02 0.00000000000000000e+00 1.85185185185185140e-02 0.00000000000000000e+00 1.85185185185185210e-02 0.00000000000000000e+00 1.85185185185185210e-02 0.00000000000000000e+00 1.85185185185185036e-02 0.00000000000000000e+00 1.85185185185185140e-02 0.00000000000000000e+00 1.85185185185185071e-02 0.00000000000000000e+00 1.85185185185185036e-02 0.00000000000000000e+00 1.85185185185185071e-02 0.00000000000000000e+00 7.40740740740740561e-02 0.00000000000000000e+00 7.40740740740741255e-02 0.00000000000000000e+00 7.40740740740740700e-02 0.00000000000000000e+00 7.40740740740741394e-02 0.00000000000000000e+00 7.40740740740740422e-02 0.00000000000000000e+00 7.40740740740741255e-02 0.00000000000000000e+00 2.96296296296296835e-01 0.00000000000000000e+00 2.81465216025196096e-03 4.42093577867884446e-03 2.81465216025195879e-03 4.42093577867884620e-03 2.81465216025195922e-03 4.42093577867884880e-03 2.81465216025195966e-03 4.42093577867884620e-03 2.81465216025195966e-03 -4.42093577867885314e-03 2.81465216025196139e-03 -4.42093577867885227e-03 2.81465216025196009e-03 -4.42093577867884880e-03 2.81465216025195706e-03 -4.42093577867885053e-03 1.12586086410078317e-02 1.76837431147153744e-02 1.12586086410078248e-02 1.76837431147153813e-02 1.12586086410078386e-02 1.76837431147153744e-02 1.12586086410078265e-02 1.76837431147153917e-02 1.12586086410078404e-02 -1.76837431147153709e-02 1.12586086410078404e-02 -1.76837431147153917e-02 1.12586086410078334e-02 -1.76837431147153709e-02 1.12586086410078369e-02 -1.76837431147153709e-02 -5.62930432050391671e-03 2.53432257818486661e-18 -5.62930432050391845e-03 2.76471553983803631e-18 -5.62930432050392192e-03 2.13452302708083685e-18 -5.62930432050392192e-03 1.68051336735253187e-18 -2.25172172820156842e-02 1.24141148749590258e-17 -2.25172172820156911e-02 1.23599047663347505e-17 -2.25172172820156807e-02 1.02457105299880169e-17 -2.25172172820156842e-02 1.55854062294791262e-17 4.50344345640313545e-02 7.07349724588614281e-02 4.50344345640313753e-02 -7.07349724588614837e-02 -9.00688691280627229e-02 4.94396190653390022e-17 6.89387659566726395e-04 2.22819243099996091e-03 6.89387659566725744e-04 2.22819243099996091e-03 6.89387659566725744e-04 2.22819243099995831e-03 6.89387659566725744e-04 2.22819243099996005e-03 6.89387659566734418e-04 -2.22819243099995918e-03 6.89387659566735068e-04 -2.22819243099996091e-03 6.89387659566734526e-04 -2.22819243099995875e-03 6.89387659566734418e-04 -2.22819243099995744e-03 2.75755063826689604e-03 8.91276972399982631e-03 2.75755063826689604e-03 8.91276972399983325e-03 2.75755063826690254e-03 8.91276972399982631e-03 2.75755063826689517e-03 8.91276972399983151e-03 2.75755063826692726e-03 -8.91276972399983151e-03 2.75755063826692379e-03 -8.91276972399983498e-03 2.75755063826693594e-03 -8.91276972399982804e-03 2.75755063826692900e-03 -8.91276972399983325e-03 -1.34911322749102849e-03 5.63785129692462306e-18 -1.34911322749103478e-03 7.04731412115577882e-18 -1.34911322749103153e-03 5.73949525059513910e-18 -1.34911322749102828e-03 6.93889390390722838e-18 -5.39645290996411311e-03 2.33103467084383453e-17 -5.39645290996411224e-03 2.53703308361608038e-17 -5.39645290996410617e-03 2.19008838842071896e-17 -5.39645290996411137e-03 2.18195687212707767e-17 1.10302025530675737e-02 3.56510788959993122e-02 1.10302025530676449e-02 -3.56510788959993399e-02 -2.15858116398563379e-02 9.58434720477185920e-17 2.81465216025196226e-03 4.42093577867884620e-03 2.81465216025196053e-03 4.42093577867884707e-03 2.81465216025196009e-03 -4.42093577867884446e-03 2.81465216025196139e-03 -4.42093577867884793e-03 2.81465216025196139e-03 4.42093577867885140e-03 2.81465216025196313e-03 4.42093577867884620e-03 2.81465216025196009e-03 -4.42093577867884620e-03 2.81465216025196009e-03 -4.42093577867884793e-03 -5.62930432050392105e-03 2.41234983378024737e-18 -5.62930432050392192e-03 5.04154010205759562e-18 1.12586086410078334e-02 1.76837431147153779e-02 1.12586086410078369e-02 -1.76837431147153744e-02 -5.62930432050391585e-03 2.09386544561263044e-18 -5.62930432050391498e-03 1.68051336735253187e-18 1.12586086410078404e-02 1.76837431147153848e-02 1.12586086410078490e-02 -1.76837431147153779e-02 1.12586086410078317e-02 1.76837431147153744e-02 1.12586086410078248e-02 1.76837431147153813e-02 1.12586086410078404e-02 -1.76837431147153674e-02 1.12586086410078404e-02 -1.76837431147153848e-02 -2.25172172820156634e-02 1.06251812903579435e-17 -2.25172172820156391e-02 1.36609473733173559e-17 4.50344345640313753e-02 7.07349724588614559e-02 4.50344345640313892e-02 -7.07349724588615392e-02 -2.25172172820156738e-02 1.00288700954909160e-17 -2.25172172820156669e-02 1.01643953670516041e-17 -9.00688691280626813e-02 5.81132364452230377e-17 -2.51043977721420765e-03 5.37554726199082795e-03 -2.51043977721420938e-03 5.37554726199082535e-03 5.93285902756137112e-03 2.29715335295366252e-18 5.93285902756137285e-03 1.92445885616177037e-18 5.93285902756137372e-03 2.00238588730916600e-18 5.93285902756137372e-03 2.25649577148545610e-18 -2.51043977721420244e-03 -5.37554726199083142e-03 -2.51043977721420244e-03 -5.37554726199083403e-03 -3.42241925034716217e-03 -5.37554726199082709e-03 -3.42241925034716520e-03 -5.37554726199083142e-03 -1.00417591088568306e-02 2.15021890479633083e-02 2.37314361102454706e-02 7.75204553327135670e-18 -3.42241925034715740e-03 5.37554726199083316e-03 -3.42241925034715870e-03 5.37554726199083576e-03 2.37314361102454636e-02 9.37834879199961335e-18 -1.00417591088568098e-02 -2.15021890479633292e-02 -3.42241925034716217e-03 -5.37554726199082969e-03 -3.42241925034716303e-03 -5.37554726199083142e-03 -3.42241925034716087e-03 5.37554726199083489e-03 -3.42241925034715913e-03 5.37554726199083750e-03 6.84483850069434081e-03 -8.89045781438113636e-18 6.84483850069434775e-03 -7.58941520739853104e-18 -1.36896770013886521e-02 -2.15021890479633430e-02 -1.36896770013886556e-02 2.15021890479633465e-02 -1.36896770013886712e-02 -2.15021890479633430e-02 -1.36896770013886435e-02 2.15021890479633708e-02 2.73793540027773043e-02 -3.18755438710738304e-17 -1.70862678174353295e-03 2.01297424512872835e-03 -1.70862678174353339e-03 2.01297424512873009e-03 2.54687373473176052e-03 6.96351183079584372e-04 2.54687373473176226e-03 6.96351183079583829e-04 2.54687373473176356e-03 -6.96351183079577324e-04 2.54687373473176356e-03 -6.96351183079577541e-04 -1.70862678174352515e-03 -2.01297424512873356e-03 -1.70862678174352601e-03 -2.01297424512873529e-03 -8.38246952988226917e-04 -2.70932542820831327e-03 -8.38246952988228218e-04 -2.70932542820831413e-03 -6.83450712697413528e-03 8.05189698051490300e-03 1.01874949389270698e-02 2.78540473231833705e-03 -8.38246952988235482e-04 2.70932542820831804e-03 -8.38246952988239060e-04 2.70932542820831804e-03 1.01874949389270646e-02 -2.78540473231830756e-03 -6.83450712697409972e-03 -8.05189698051493596e-03 -8.20213443399341199e-04 -1.28829807437125395e-03 -8.20213443399340656e-04 -1.28829807437125504e-03 -8.20213443399322225e-04 1.28829807437125742e-03 -8.20213443399323960e-04 1.28829807437125937e-03 1.64042688679867784e-03 -8.57536155800253663e-18 1.64042688679867416e-03 -7.23704950134074210e-18 -3.28085377359737477e-03 -5.15319229748503228e-03 -3.28085377359730842e-03 5.15319229748503315e-03 -3.35298781195290897e-03 -1.08373017128332774e-02 -3.35298781195295407e-03 1.08373017128332600e-02 6.56170754719473306e-03 -2.97681258983051311e-17 6.89387659566723576e-04 2.22819243099995918e-03 6.89387659566727371e-04 2.22819243099995658e-03 6.89387659566733008e-04 -2.22819243099995571e-03 6.89387659566733225e-04 -2.22819243099995788e-03 6.89387659566726503e-04 2.22819243099995831e-03 6.89387659566726286e-04 2.22819243099995875e-03 6.89387659566732575e-04 -2.22819243099996048e-03 6.89387659566733334e-04 -2.22819243099995788e-03 -1.34911322749102676e-03 7.20994444702860449e-18 -1.34911322749102871e-03 5.96311194867027439e-18 2.75755063826689560e-03 8.91276972399981937e-03 2.75755063826692510e-03 -8.91276972399982978e-03 -1.34911322749102763e-03 7.78592685116152872e-18 -1.34911322749102372e-03 6.01732205729454961e-18 2.75755063826689994e-03 8.91276972399983151e-03 2.75755063826692640e-03 -8.91276972399983151e-03 2.75755063826690081e-03 8.91276972399982978e-03 2.75755063826690168e-03 8.91276972399982284e-03 2.75755063826692336e-03 -8.91276972399982111e-03 2.75755063826692813e-03 -8.91276972399983325e-03 -5.39645290996410964e-03 2.45029690981724002e-17 -5.39645290996411398e-03 2.14672030152129878e-17 1.10302025530675876e-02 3.56510788959993191e-02 1.10302025530676917e-02 -3.56510788959992775e-02 -5.39645290996411051e-03 2.39066579033053728e-17 -5.39645290996412352e-03 2.44758640438602626e-17 -2.15858116398563657e-02 9.80118763926896008e-17 -1.70862678174353274e-03 2.01297424512872792e-03 -1.70862678174353295e-03 2.01297424512873009e-03 2.54687373473176399e-03 -6.96351183079577107e-04 2.54687373473176486e-03 -6.96351183079577649e-04 2.54687373473176095e-03 6.96351183079583829e-04 2.54687373473176095e-03 6.96351183079584046e-04 -1.70862678174352536e-03 -2.01297424512873312e-03 -1.70862678174352710e-03 -2.01297424512873573e-03 -8.20213443399341524e-04 -1.28829807437125178e-03 -8.20213443399341957e-04 -1.28829807437125048e-03 -6.83450712697413702e-03 8.05189698051492729e-03 1.01874949389270525e-02 -2.78540473231831060e-03 -8.20213443399326237e-04 1.28829807437126219e-03 -8.20213443399326562e-04 1.28829807437126154e-03 1.01874949389270456e-02 2.78540473231833749e-03 -6.83450712697409972e-03 -8.05189698051495852e-03 -8.38246952988226158e-04 -2.70932542820831370e-03 -8.38246952988228435e-04 -2.70932542820831717e-03 -8.38246952988241554e-04 2.70932542820831847e-03 -8.38246952988241228e-04 2.70932542820832021e-03 1.64042688679868175e-03 -6.71527720583209309e-18 1.64042688679868305e-03 -7.23704950134074210e-18 -3.35298781195291027e-03 -1.08373017128332617e-02 -3.35298781195294757e-03 1.08373017128332756e-02 -3.28085377359737390e-03 -5.15319229748502448e-03 -3.28085377359731145e-03 5.15319229748504009e-03 6.56170754719468709e-03 -2.60953910390104848e-17 -9.69750611510963845e-04 6.63590173710823213e-04 -9.69750611510964713e-04 6.63590173710824406e-04 1.17506092062133168e-03 4.61124736485241105e-18 1.17506092062133168e-03 3.84214144874550634e-18 1.17506092062133038e-03 4.11319199186688245e-18 1.17506092062133146e-03 4.11319199186688245e-18 -9.69750611510957448e-04 -6.63590173710833730e-04 -9.69750611510956906e-04 -6.63590173710835139e-04 -2.00893394244360657e-04 -6.49314118524403844e-04 -2.00893394244361660e-04 -6.49314118524403410e-04 -3.87900244604385365e-03 2.65436069484329762e-03 4.70024368248532151e-03 1.54905385393866446e-17 -2.00893394244353501e-04 6.49314118524405254e-04 -2.00893394244356049e-04 6.49314118524404278e-04 4.70024368248532064e-03 1.97934659114384903e-17 -3.87900244604383109e-03 -2.65436069484333492e-03 -2.00893394244360034e-04 -6.49314118524403627e-04 -2.00893394244360305e-04 -6.49314118524403410e-04 -2.00893394244355480e-04 6.49314118524402326e-04 -2.00893394244352472e-04 6.49314118524402868e-04 3.93143004127714975e-04 -6.61363325216157705e-18 3.93143004127721263e-04 -7.80625564189563192e-18 -8.03573576977445123e-04 -2.59725647409761061e-03 -8.03573576977410537e-04 2.59725647409761928e-03 -8.03573576977446640e-04 -2.59725647409761321e-03 -8.03573576977414765e-04 2.59725647409762492e-03 1.57257201651088093e-03 -2.14672030152129878e-17 2.81465216025196096e-03 4.42093577867884793e-03 2.81465216025196053e-03 -4.42093577867884360e-03 2.81465216025196053e-03 4.42093577867884793e-03 2.81465216025196139e-03 -4.42093577867884533e-03 2.81465216025195966e-03 4.42093577867885053e-03 2.81465216025196269e-03 -4.42093577867885140e-03 2.81465216025196269e-03 4.42093577867884707e-03 2.81465216025196096e-03 -4.42093577867884880e-03 1.12586086410078317e-02 1.76837431147153744e-02 1.12586086410078404e-02 -1.76837431147153709e-02 -5.62930432050391932e-03 2.10064170919066484e-18 -5.62930432050391932e-03 3.70661617718481828e-18 1.12586086410078404e-02 1.76837431147153917e-02 1.12586086410078404e-02 -1.76837431147153883e-02 -5.62930432050391411e-03 2.60886147754324504e-18 -5.62930432050392192e-03 3.33392168039292613e-18 1.12586086410078352e-02 1.76837431147153744e-02 1.12586086410078369e-02 -1.76837431147153744e-02 1.12586086410078456e-02 1.76837431147153848e-02 1.12586086410078404e-02 -1.76837431147153813e-02 4.50344345640313962e-02 7.07349724588614698e-02 4.50344345640314031e-02 -7.07349724588614975e-02 -2.25172172820156634e-02 1.00830802041151912e-17 -2.25172172820156426e-02 1.11672823766006957e-17 -2.25172172820156703e-02 1.30646361784503284e-17 -2.25172172820156669e-02 1.02999206386122921e-17 -9.00688691280626952e-02 5.94142790522056430e-17 -2.51043977721420938e-03 5.37554726199083056e-03 5.93285902756137112e-03 2.22261445359528409e-18 -2.51043977721420808e-03 5.37554726199083056e-03 5.93285902756137372e-03 2.35136346157793774e-18 5.93285902756137545e-03 2.12266456581927665e-18 -2.51043977721420548e-03 -5.37554726199082275e-03 5.93285902756137372e-03 2.26242500211623621e-18 -2.51043977721420375e-03 -5.37554726199082882e-03 -1.00417591088568254e-02 2.15021890479633222e-02 2.37314361102454636e-02 1.05709711817336682e-17 -3.42241925034716477e-03 -5.37554726199083056e-03 -3.42241925034716434e-03 -5.37554726199082882e-03 2.37314361102454602e-02 1.01711716306296385e-17 -1.00417591088568098e-02 -2.15021890479633153e-02 -3.42241925034715956e-03 5.37554726199083229e-03 -3.42241925034716087e-03 5.37554726199083229e-03 -3.42241925034716737e-03 -5.37554726199082795e-03 -3.42241925034716173e-03 5.37554726199083403e-03 -3.42241925034716217e-03 -5.37554726199082882e-03 -3.42241925034716217e-03 5.37554726199083576e-03 -1.36896770013886643e-02 -2.15021890479633396e-02 -1.36896770013886469e-02 2.15021890479633430e-02 6.84483850069433561e-03 -8.78203759713258592e-18 6.84483850069434862e-03 -7.53520509877425582e-18 -1.36896770013886625e-02 -2.15021890479633569e-02 -1.36896770013886573e-02 2.15021890479633777e-02 2.73793540027773112e-02 -2.68882138776405100e-17 -1.70862678174353317e-03 2.01297424512872965e-03 2.54687373473176182e-03 6.96351183079584588e-04 -1.70862678174353447e-03 2.01297424512873096e-03 2.54687373473175922e-03 6.96351183079584046e-04 2.54687373473176529e-03 -6.96351183079576565e-04 -1.70862678174352536e-03 -2.01297424512873703e-03 2.54687373473176312e-03 -6.96351183079577433e-04 -1.70862678174352666e-03 -2.01297424512873789e-03 -6.83450712697413615e-03 8.05189698051490994e-03 1.01874949389270525e-02 2.78540473231833575e-03 -8.38246952988226917e-04 -2.70932542820831197e-03 -8.38246952988227784e-04 -2.70932542820831153e-03 1.01874949389270664e-02 -2.78540473231831103e-03 -6.83450712697410232e-03 -8.05189698051493770e-03 -8.38246952988236892e-04 2.70932542820831760e-03 -8.38246952988236783e-04 2.70932542820831760e-03 -8.20213443399340982e-04 -1.28829807437125200e-03 -8.20213443399326128e-04 1.28829807437125894e-03 -8.20213443399343042e-04 -1.28829807437125222e-03 -8.20213443399326020e-04 1.28829807437125959e-03 -3.28085377359736783e-03 -5.15319229748502361e-03 -3.28085377359731319e-03 5.15319229748503489e-03 1.64042688679868348e-03 -6.99310401253150360e-18 1.64042688679868305e-03 -5.15080735225340036e-18 -3.35298781195291417e-03 -1.08373017128332721e-02 -3.35298781195296188e-03 1.08373017128332635e-02 6.56170754719473046e-03 -2.49366499671666020e-17 -2.51043977721420722e-03 5.37554726199083056e-03 5.93285902756137112e-03 2.00577401909818320e-18 5.93285902756137285e-03 2.41573796556926457e-18 -2.51043977721420375e-03 -5.37554726199082969e-03 -2.51043977721420895e-03 5.37554726199082449e-03 5.93285902756137632e-03 2.24971950790742170e-18 5.93285902756137545e-03 2.18788610275785778e-18 -2.51043977721420331e-03 -5.37554726199082622e-03 -3.42241925034716477e-03 -5.37554726199082795e-03 -3.42241925034716087e-03 5.37554726199083229e-03 -3.42241925034716043e-03 -5.37554726199083403e-03 -3.42241925034716000e-03 5.37554726199083403e-03 -3.42241925034716303e-03 -5.37554726199082795e-03 -3.42241925034716173e-03 5.37554726199083663e-03 -3.42241925034716390e-03 -5.37554726199082535e-03 -3.42241925034716130e-03 5.37554726199083056e-03 -1.00417591088568289e-02 2.15021890479633222e-02 2.37314361102454879e-02 8.61940727125976025e-18 2.37314361102454775e-02 9.46644021851406059e-18 -1.00417591088568167e-02 -2.15021890479633396e-02 -1.36896770013886608e-02 -2.15021890479633396e-02 -1.36896770013886521e-02 2.15021890479633569e-02 -1.36896770013886591e-02 -2.15021890479633257e-02 -1.36896770013886435e-02 2.15021890479633604e-02 6.84483850069433995e-03 -7.58941520739853104e-18 6.84483850069433821e-03 -9.13440330319037486e-18 2.73793540027772800e-02 -3.07913416985883259e-17 -6.65948821592867845e-03 8.70869379353939673e-04 3.60696984733351956e-03 5.66541836887763783e-03 3.60696984733352259e-03 5.66541836887763609e-03 3.60696984733352953e-03 -5.66541836887762568e-03 3.60696984733352346e-03 5.66541836887763262e-03 3.60696984733352996e-03 -5.66541836887763089e-03 3.60696984733352996e-03 -5.66541836887762915e-03 -6.65948821592867498e-03 -8.70869379353946720e-04 3.05251836859515759e-03 -6.53628774823157826e-03 -7.21393969466705906e-03 6.91517698138410797e-18 3.05251836859515759e-03 -6.53628774823157826e-03 -7.21393969466705646e-03 8.15925662266386159e-18 -7.21393969466705559e-03 1.85394336330284987e-18 3.05251836859516323e-03 6.53628774823157045e-03 -7.21393969466705472e-03 6.23839765652792200e-19 3.05251836859516497e-03 6.53628774823156091e-03 3.05251836859515803e-03 -6.53628774823157652e-03 -7.21393969466705125e-03 1.82959116606928873e-18 -7.21393969466706253e-03 2.78589136351939382e-18 3.05251836859515629e-03 6.53628774823157479e-03 4.16142132607189453e-03 6.53628774823156698e-03 4.16142132607190060e-03 -6.53628774823158259e-03 4.16142132607190667e-03 6.53628774823156958e-03 4.16142132607190060e-03 -6.53628774823157999e-03 4.16142132607191188e-03 6.53628774823158086e-03 4.16142132607190147e-03 -6.53628774823157219e-03 -8.32284265214379947e-03 1.87838026383113643e-17 -2.96101870361584283e-03 -4.07787904274920518e-04 8.83448596702765001e-04 2.85542314115083597e-03 8.83448596702764567e-04 2.85542314115083467e-03 2.21337090413717885e-03 -2.00870903287528411e-03 2.21337090413717234e-03 2.00870903287529365e-03 8.83448596702778445e-04 -2.85542314115083684e-03 8.83448596702778662e-04 -2.85542314115083727e-03 -2.96101870361584283e-03 4.07787904274910652e-04 2.07757010691307729e-03 -2.44763523687591394e-03 -3.09681950083994569e-03 -8.46714108275548288e-04 2.07757010691307815e-03 -2.44763523687591264e-03 -3.09681950083994569e-03 -8.46714108275549589e-04 -3.09681950083995306e-03 8.46714108275544168e-04 2.07757010691307469e-03 2.44763523687592435e-03 -3.09681950083995393e-03 8.46714108275543843e-04 2.07757010691307599e-03 2.44763523687592435e-03 7.31563382216005335e-04 -1.56647993388948025e-03 -1.72888529563928594e-03 4.60785923306339384e-18 -1.72888529563927857e-03 5.56331239756624463e-18 7.31563382216022791e-04 1.56647993388948480e-03 9.97321913423274533e-04 1.56647993388947266e-03 9.97321913423266943e-04 -1.56647993388949304e-03 9.97321913423273665e-04 1.56647993388947266e-03 9.97321913423267811e-04 -1.56647993388949261e-03 1.01924939392687968e-03 3.29434934515146927e-03 1.01924939392687773e-03 -3.29434934515145279e-03 -1.99464382684651220e-03 -4.98732999343332040e-18 -1.70862678174353295e-03 2.01297424512872879e-03 2.54687373473176139e-03 6.96351183079584155e-04 2.54687373473176312e-03 -6.96351183079577216e-04 -1.70862678174352536e-03 -2.01297424512873659e-03 -1.70862678174353425e-03 2.01297424512873009e-03 2.54687373473176182e-03 6.96351183079584155e-04 2.54687373473176529e-03 -6.96351183079577649e-04 -1.70862678174352666e-03 -2.01297424512873789e-03 -8.20213443399342391e-04 -1.28829807437125547e-03 -8.20213443399326670e-04 1.28829807437125959e-03 -8.38246952988226483e-04 -2.70932542820831717e-03 -8.38246952988237217e-04 2.70932542820831977e-03 -8.20213443399343909e-04 -1.28829807437125373e-03 -8.20213443399326128e-04 1.28829807437125916e-03 -8.38246952988226375e-04 -2.70932542820831587e-03 -8.38246952988239168e-04 2.70932542820832107e-03 -6.83450712697413615e-03 8.05189698051491341e-03 1.01874949389270438e-02 2.78540473231833705e-03 1.01874949389270508e-02 -2.78540473231830886e-03 -6.83450712697409798e-03 -8.05189698051493596e-03 -3.28085377359736696e-03 -5.15319229748501841e-03 -3.28085377359731015e-03 5.15319229748504876e-03 -3.35298781195290550e-03 -1.08373017128332687e-02 -3.35298781195295971e-03 1.08373017128332652e-02 1.64042688679868348e-03 -7.49962971498957520e-18 1.64042688679868196e-03 -9.36225516600178165e-18 6.56170754719470964e-03 -3.43488800770563873e-17 -2.96101870361584413e-03 -4.07787904274921115e-04 8.83448596702767711e-04 2.85542314115083511e-03 2.21337090413717234e-03 2.00870903287529148e-03 8.83448596702775843e-04 -2.85542314115083120e-03 8.83448596702768904e-04 2.85542314115083641e-03 2.21337090413717798e-03 -2.00870903287528324e-03 8.83448596702779963e-04 -2.85542314115083294e-03 -2.96101870361584500e-03 4.07787904274909785e-04 7.31563382216000456e-04 -1.56647993388948350e-03 -1.72888529563928008e-03 1.08420217248550443e-17 2.07757010691308032e-03 -2.44763523687591437e-03 -3.09681950083996044e-03 8.46714108275545795e-04 -1.72888529563927705e-03 8.60585474410369144e-18 7.31563382216014876e-04 1.56647993388947244e-03 -3.09681950083994439e-03 -8.46714108275552083e-04 2.07757010691307512e-03 2.44763523687592608e-03 2.07757010691307512e-03 -2.44763523687592001e-03 -3.09681950083994656e-03 -8.46714108275550348e-04 -3.09681950083995220e-03 8.46714108275545252e-04 2.07757010691307252e-03 2.44763523687592261e-03 9.97321913423274099e-04 1.56647993388947179e-03 9.97321913423261739e-04 -1.56647993388948372e-03 1.01924939392687036e-03 3.29434934515146364e-03 1.01924939392688272e-03 -3.29434934515147361e-03 9.97321913423278653e-04 1.56647993388948697e-03 9.97321913423268678e-04 -1.56647993388949456e-03 -1.99464382684654039e-03 2.38524477946810975e-18 -1.22325124210550585e-03 -5.22596806315349513e-04 4.41026397524657779e-05 1.32947582920883820e-03 7.14395755869367361e-04 1.12209167507806677e-03 7.14395755869371590e-04 -1.12209167507805875e-03 7.14395755869366277e-04 1.12209167507806656e-03 7.14395755869372024e-04 -1.12209167507806439e-03 4.41026397524751495e-05 -1.32947582920883841e-03 -1.22325124210551106e-03 5.22596806315342032e-04 4.97908294292653104e-04 -5.86597719031621469e-04 -7.42180545563636421e-04 -2.02922623887480218e-04 1.17914860235303668e-03 -8.06879022893489659e-04 -1.42879151173874556e-03 -2.77826806699410511e-18 -7.42180545563636746e-04 2.02922623887490003e-04 4.97908294292652778e-04 5.86597719031615615e-04 -1.42879151173873971e-03 -1.60597446799415344e-18 1.17914860235302779e-03 8.06879022893496924e-04 4.97908294292652236e-04 -5.86597719031622445e-04 -7.42180545563633385e-04 -2.02922623887484012e-04 -7.42180545563637505e-04 2.02922623887486371e-04 4.97908294292650935e-04 5.86597719031620494e-04 2.39017134064896288e-04 3.75420954186462489e-04 2.39017134064888428e-04 -3.75420954186468777e-04 2.44272251270987437e-04 7.89520342919096374e-04 2.44272251270959736e-04 -7.89520342919108843e-04 2.44272251270991124e-04 7.89520342919108084e-04 2.44272251270964236e-04 -7.89520342919107650e-04 -4.78034268129859797e-04 -5.42101086242752217e-18 6.89387659566723251e-04 2.22819243099995528e-03 6.89387659566730515e-04 -2.22819243099995744e-03 6.89387659566726286e-04 2.22819243099995831e-03 6.89387659566732900e-04 -2.22819243099995788e-03 6.89387659566729322e-04 2.22819243099995831e-03 6.89387659566733551e-04 -2.22819243099995831e-03 6.89387659566726178e-04 2.22819243099996091e-03 6.89387659566732466e-04 -2.22819243099996091e-03 2.75755063826689517e-03 8.91276972399982284e-03 2.75755063826692206e-03 -8.91276972399983325e-03 -1.34911322749102351e-03 6.23416249179165050e-18 -1.34911322749102502e-03 6.05120337518472162e-18 2.75755063826689734e-03 8.91276972399983151e-03 2.75755063826692900e-03 -8.91276972399983672e-03 -1.34911322749102437e-03 6.32903018188413213e-18 -1.34911322749102502e-03 5.62768690155757145e-18 2.75755063826689691e-03 8.91276972399983151e-03 2.75755063826692466e-03 -8.91276972399982804e-03 2.75755063826689474e-03 8.91276972399982804e-03 2.75755063826692249e-03 -8.91276972399983151e-03 1.10302025530675998e-02 3.56510788959993122e-02 1.10302025530676882e-02 -3.56510788959993052e-02 -5.39645290996411831e-03 2.32019264911897949e-17 -5.39645290996411137e-03 2.39337629576175104e-17 -5.39645290996410010e-03 2.37982376860568223e-17 -5.39645290996411484e-03 2.37711326317446847e-17 -2.15858116398563692e-02 9.49761103097301884e-17 -1.70862678174353360e-03 2.01297424512873096e-03 2.54687373473176182e-03 -6.96351183079577324e-04 -1.70862678174353339e-03 2.01297424512873096e-03 2.54687373473176529e-03 -6.96351183079577433e-04 2.54687373473175879e-03 6.96351183079584372e-04 -1.70862678174352623e-03 -2.01297424512873659e-03 2.54687373473176226e-03 6.96351183079584372e-04 -1.70862678174352710e-03 -2.01297424512873703e-03 -6.83450712697413702e-03 8.05189698051492209e-03 1.01874949389270560e-02 -2.78540473231831103e-03 -8.20213443399340656e-04 -1.28829807437125373e-03 -8.20213443399342283e-04 -1.28829807437125243e-03 1.01874949389270438e-02 2.78540473231833662e-03 -6.83450712697410145e-03 -8.05189698051495158e-03 -8.20213443399327104e-04 1.28829807437126154e-03 -8.20213443399326020e-04 1.28829807437126046e-03 -8.38246952988226375e-04 -2.70932542820831630e-03 -8.38246952988236783e-04 2.70932542820831760e-03 -8.38246952988226592e-04 -2.70932542820831283e-03 -8.38246952988239494e-04 2.70932542820832064e-03 -3.35298781195291547e-03 -1.08373017128332652e-02 -3.35298781195295320e-03 1.08373017128332721e-02 1.64042688679868305e-03 -6.12574227454310005e-18 1.64042688679868435e-03 -8.04935409775761612e-18 -3.28085377359736870e-03 -5.15319229748501754e-03 -3.28085377359730538e-03 5.15319229748504529e-03 6.56170754719469229e-03 -3.05745012640912250e-17 -9.69750611510964496e-04 6.63590173710824948e-04 1.17506092062133103e-03 3.95733792957209118e-18 -9.69750611510965580e-04 6.63590173710823972e-04 1.17506092062133059e-03 3.93023287525995357e-18 1.17506092062133125e-03 4.23685880216601030e-18 -9.69750611510957232e-04 -6.63590173710832320e-04 1.17506092062133016e-03 4.00053660988206050e-18 -9.69750611510957665e-04 -6.63590173710834272e-04 -3.87900244604385885e-03 2.65436069484329676e-03 4.70024368248532325e-03 1.73472347597680709e-17 -2.00893394244361389e-04 -6.49314118524404712e-04 -2.00893394244361091e-04 -6.49314118524403953e-04 4.70024368248532672e-03 1.76860479386697911e-17 -3.87900244604383066e-03 -2.65436069484333232e-03 -2.00893394244354044e-04 6.49314118524404495e-04 -2.00893394244353285e-04 6.49314118524404278e-04 -2.00893394244360278e-04 -6.49314118524402326e-04 -2.00893394244352092e-04 6.49314118524408615e-04 -2.00893394244362555e-04 -6.49314118524405254e-04 -2.00893394244353745e-04 6.49314118524403085e-04 -8.03573576977448809e-04 -2.59725647409761451e-03 -8.03573576977409561e-04 2.59725647409761624e-03 3.93143004127715734e-04 -6.83047368665867793e-18 3.93143004127721480e-04 -4.90601483049690756e-18 -8.03573576977440894e-04 -2.59725647409761451e-03 -8.03573576977422029e-04 2.59725647409761538e-03 1.57257201651090240e-03 -2.16840434497100887e-17 -1.70862678174353295e-03 2.01297424512872705e-03 2.54687373473176312e-03 -6.96351183079576999e-04 2.54687373473176052e-03 6.96351183079583938e-04 -1.70862678174352623e-03 -2.01297424512873746e-03 -1.70862678174353339e-03 2.01297424512873052e-03 2.54687373473176703e-03 -6.96351183079577758e-04 2.54687373473176095e-03 6.96351183079584697e-04 -1.70862678174352623e-03 -2.01297424512873789e-03 -8.38246952988226592e-04 -2.70932542820831283e-03 -8.38246952988239819e-04 2.70932542820831717e-03 -8.20213443399341957e-04 -1.28829807437125482e-03 -8.20213443399326779e-04 1.28829807437125482e-03 -8.38246952988225182e-04 -2.70932542820831674e-03 -8.38246952988237976e-04 2.70932542820832107e-03 -8.20213443399342933e-04 -1.28829807437125677e-03 -8.20213443399328513e-04 1.28829807437126111e-03 -6.83450712697413181e-03 8.05189698051491168e-03 1.01874949389270525e-02 -2.78540473231831147e-03 1.01874949389270403e-02 2.78540473231833705e-03 -6.83450712697409712e-03 -8.05189698051494637e-03 -3.35298781195290984e-03 -1.08373017128332704e-02 -3.35298781195296188e-03 1.08373017128332669e-02 -3.28085377359737217e-03 -5.15319229748501841e-03 -3.28085377359730538e-03 5.15319229748504096e-03 1.64042688679868261e-03 -7.21163851292311309e-18 1.64042688679868370e-03 -7.63261388770850036e-18 6.56170754719471137e-03 -2.73286710102127461e-17 -2.96101870361584587e-03 -4.07787904274920464e-04 2.21337090413717148e-03 2.00870903287529278e-03 8.83448596702764350e-04 2.85542314115083641e-03 8.83448596702776385e-04 -2.85542314115083207e-03 8.83448596702768037e-04 2.85542314115083684e-03 8.83448596702779095e-04 -2.85542314115083381e-03 2.21337090413717711e-03 -2.00870903287528497e-03 -2.96101870361584196e-03 4.07787904274908321e-04 2.07757010691308119e-03 -2.44763523687591524e-03 -3.09681950083995957e-03 8.46714108275545578e-04 7.31563382216000348e-04 -1.56647993388948112e-03 -1.72888529563927705e-03 1.09097843606353884e-17 -3.09681950083994482e-03 -8.46714108275551107e-04 2.07757010691307469e-03 2.44763523687592435e-03 -1.72888529563927770e-03 8.67361737988403547e-18 7.31563382216014876e-04 1.56647993388947049e-03 2.07757010691307512e-03 -2.44763523687591871e-03 -3.09681950083995090e-03 8.46714108275547096e-04 -3.09681950083994352e-03 -8.46714108275551432e-04 2.07757010691307252e-03 2.44763523687592521e-03 1.01924939392687361e-03 3.29434934515146580e-03 1.01924939392688293e-03 -3.29434934515146927e-03 9.97321913423272581e-04 1.56647993388947570e-03 9.97321913423258920e-04 -1.56647993388948892e-03 9.97321913423282122e-04 1.56647993388948350e-03 9.97321913423268027e-04 -1.56647993388949348e-03 -1.99464382684654690e-03 8.45677694538693459e-18 -1.22325124210550563e-03 -5.22596806315349729e-04 7.14395755869366494e-04 1.12209167507806677e-03 4.41026397524665301e-05 1.32947582920883668e-03 7.14395755869371698e-04 -1.12209167507806005e-03 7.14395755869366711e-04 1.12209167507806721e-03 4.41026397524745125e-05 -1.32947582920883885e-03 7.14395755869372349e-04 -1.12209167507806395e-03 -1.22325124210551192e-03 5.22596806315341164e-04 1.17914860235303668e-03 -8.06879022893487816e-04 -1.42879151173874405e-03 -2.05998412772245842e-18 4.97908294292655164e-04 -5.86597719031619301e-04 -7.42180545563633819e-04 -2.02922623887478835e-04 -1.42879151173874058e-03 -1.21972744404619249e-18 1.17914860235302605e-03 8.06879022893496815e-04 -7.42180545563637831e-04 2.02922623887491141e-04 4.97908294292649634e-04 5.86597719031614747e-04 4.97908294292652453e-04 -5.86597719031621686e-04 -7.42180545563636855e-04 2.02922623887487157e-04 -7.42180545563634253e-04 -2.02922623887484283e-04 4.97908294292651911e-04 5.86597719031619626e-04 2.44272251270991774e-04 7.89520342919100494e-04 2.44272251270964886e-04 -7.89520342919105265e-04 2.39017134064896153e-04 3.75420954186467747e-04 2.39017134064886287e-04 -3.75420954186464061e-04 2.44272251270990040e-04 7.89520342919108409e-04 2.44272251270961688e-04 -7.89520342919108301e-04 -4.78034268129858605e-04 -1.73472347597680709e-18 -9.69750611510963628e-04 6.63590173710825490e-04 1.17506092062132994e-03 4.33680868994201774e-18 1.17506092062133103e-03 4.44184077540155098e-18 -9.69750611510957882e-04 -6.63590173710835464e-04 -9.69750611510965146e-04 6.63590173710823863e-04 1.17506092062133081e-03 4.28937484489577692e-18 1.17506092062133016e-03 4.14283814502078296e-18 -9.69750611510957991e-04 -6.63590173710834163e-04 -2.00893394244361660e-04 -6.49314118524403194e-04 -2.00893394244353691e-04 6.49314118524402760e-04 -2.00893394244360034e-04 -6.49314118524404495e-04 -2.00893394244352444e-04 6.49314118524404169e-04 -2.00893394244360711e-04 -6.49314118524403085e-04 -2.00893394244353447e-04 6.49314118524404928e-04 -2.00893394244362826e-04 -6.49314118524403844e-04 -2.00893394244352851e-04 6.49314118524403194e-04 -3.87900244604385278e-03 2.65436069484330760e-03 4.70024368248532238e-03 1.77267055201379975e-17 4.70024368248532151e-03 1.77334817837160319e-17 -3.87900244604383240e-03 -2.65436069484333145e-03 -8.03573576977441653e-04 -2.59725647409761147e-03 -8.03573576977412488e-04 2.59725647409761624e-03 -8.03573576977444255e-04 -2.59725647409760974e-03 -8.03573576977411838e-04 2.59725647409762058e-03 3.93143004127718878e-04 -6.45100292628875138e-18 3.93143004127720721e-04 -7.96888596776845759e-18 1.57257201651088332e-03 -2.71050543121376109e-17 -1.22325124210550368e-03 -5.22596806315351031e-04 7.14395755869364868e-04 1.12209167507806677e-03 7.14395755869364326e-04 1.12209167507806742e-03 4.41026397524791407e-05 -1.32947582920883668e-03 4.41026397524669095e-05 1.32947582920883755e-03 7.14395755869374192e-04 -1.12209167507806460e-03 7.14395755869373325e-04 -1.12209167507806374e-03 -1.22325124210551106e-03 5.22596806315338020e-04 4.97908294292655814e-04 -5.86597719031618650e-04 -7.42180545563635771e-04 2.02922623887486831e-04 4.97908294292654079e-04 -5.86597719031616916e-04 -7.42180545563636313e-04 2.02922623887488431e-04 -7.42180545563634578e-04 -2.02922623887484256e-04 4.97908294292662970e-04 5.86597719031611061e-04 -7.42180545563634036e-04 -2.02922623887483281e-04 4.97908294292661018e-04 5.86597719031610411e-04 1.17914860235303408e-03 -8.06879022893488142e-04 -1.42879151173874210e-03 -8.45677694538693459e-18 -1.42879151173873993e-03 -7.39290356363553336e-18 1.17914860235302735e-03 8.06879022893505489e-04 2.44272251270981149e-04 7.89520342919103964e-04 2.44272251270962935e-04 -7.89520342919111553e-04 2.44272251270980932e-04 7.89520342919101253e-04 2.44272251270962176e-04 -7.89520342919112746e-04 2.39017134064896803e-04 3.75420954186464495e-04 2.39017134064909082e-04 -3.75420954186474524e-04 -4.78034268129824995e-04 -1.60461921527854656e-17 -4.63782392664773620e-04 -3.67917140684232108e-04 1.74975659549736885e-04 5.65544559447137560e-04 1.74975659549736181e-04 5.65544559447137777e-04 1.74975659549745396e-04 -5.65544559447132790e-04 1.74975659549742062e-04 5.65544559447139295e-04 1.74975659549742252e-04 -5.65544559447138970e-04 1.74975659549743336e-04 -5.65544559447139295e-04 -4.63782392664778933e-04 3.67917140684222946e-04 2.82593529509100666e-04 -1.93375788693048558e-04 -3.42422689921496339e-04 3.83875331695648914e-18 2.82593529509101262e-04 -1.93375788693051404e-04 -3.42422689921496718e-04 4.55534319033362722e-18 -3.42422689921485280e-04 -8.65117100678179651e-18 2.82593529509108201e-04 1.93375788693043923e-04 -3.42422689921487286e-04 -9.03021825067809591e-18 2.82593529509107713e-04 1.93375788693043814e-04 2.82593529509098606e-04 -1.93375788693050970e-04 -3.42422689921490701e-04 -7.00326840789855520e-18 -3.42422689921491406e-04 -6.94101148627536413e-18 2.82593529509100232e-04 1.93375788693044329e-04 5.85420340659764627e-05 1.89215625477152721e-04 5.85420340659924005e-05 -1.89215625477162479e-04 5.85420340659733186e-05 1.89215625477151745e-04 5.85420340659912621e-05 -1.89215625477163021e-04 5.85420340659595492e-05 1.89215625477162018e-04 5.85420340660127022e-05 -1.89215625477167141e-04 -1.14565196267454395e-04 8.86335276006899875e-18 2 27 27
+DEAL:3d::2 0 3 3 2 10 FE_Q<3>(1) 10 FE_Q<3>(2) 2 0 0 0 0 0 0 512 0 0 0 0 0 3 0 0 3.47159221014868569e-02 5.34715922101486885e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 4.65284077898513171e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 9.65284077898513226e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 9.65284077898513226e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 4.65284077898513171e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 3.47159221014868569e-02 5.34715922101486885e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 4.65284077898513171e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 8.34995260896214120e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 8.34995260896214120e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 6.65004739103785880e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 3.34995260896214064e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 1.65004739103785936e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 3.34995260896214064e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 3.34995260896214064e-01 512 0 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 512 0 3 3.47159221014868569e-02 5.34715922101486885e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 4.65284077898513171e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 9.65284077898513226e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 9.65284077898513226e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 4.65284077898513171e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 3.47159221014868569e-02 5.34715922101486885e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 4.65284077898513171e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 5.34715922101486885e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 8.34995260896214120e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 3.47159221014868569e-02 3 9.65284077898513226e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 8.34995260896214120e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 6.65004739103785880e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 9.65284077898513226e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 5.34715922101486885e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 5.34715922101486885e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 4.65284077898513171e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 5.34715922101486885e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 4.65284077898513171e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 3.34995260896214064e-01 3 9.65284077898513226e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 5.34715922101486885e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 9.65284077898513226e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 4.65284077898513171e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 4.65284077898513171e-01 3 3.47159221014868569e-02 3.47159221014868569e-02 1.65004739103785936e-01 3 4.65284077898513171e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 4.65284077898513171e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 1.65004739103785936e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 8.34995260896214120e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 9.65284077898513226e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 1.65004739103785936e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 8.34995260896214120e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 8.34995260896214120e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 9.65284077898513226e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 9.65284077898513226e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 5.34715922101486885e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 4.65284077898513171e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 5.34715922101486885e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 3.47159221014868569e-02 3.34995260896214064e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 9.65284077898513226e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 5.34715922101486885e-01 3 5.34715922101486885e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 4.65284077898513171e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 3.34995260896214064e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 1.65004739103785936e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 6.65004739103785880e-01 3.47159221014868569e-02 3 8.34995260896214120e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 4.65284077898513171e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 9.65284077898513226e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 4.65284077898513171e-01 3 5.34715922101486885e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 8.34995260896214120e-01 3.34995260896214064e-01 3 9.65284077898513226e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 4.65284077898513171e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.47159221014868569e-02 6.65004739103785880e-01 3.34995260896214064e-01 3 5.34715922101486885e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 6.65004739103785880e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 3.47159221014868569e-02 3.34995260896214064e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 3.47159221014868569e-02 3 5.34715922101486885e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 4.65284077898513171e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 9.65284077898513226e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.34995260896214064e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 4.65284077898513171e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 6.65004739103785880e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 5.34715922101486885e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 9.65284077898513226e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 5.34715922101486885e-01 3 3.47159221014868569e-02 1.65004739103785936e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 9.65284077898513226e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 6.65004739103785880e-01 3.47159221014868569e-02 3.34995260896214064e-01 3 1.65004739103785936e-01 4.65284077898513171e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 1.65004739103785936e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 6.65004739103785880e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 8.34995260896214120e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 6.65004739103785880e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 8.34995260896214120e-01 1.65004739103785936e-01 3 3.34995260896214064e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 6.65004739103785880e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 6.65004739103785880e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 3.34995260896214064e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 6.65004739103785880e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 1.65004739103785936e-01 3 8.34995260896214120e-01 6.65004739103785880e-01 1.65004739103785936e-01 3 1.65004739103785936e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 6.65004739103785880e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 1.65004739103785936e-01 8.34995260896214120e-01 3 1.65004739103785936e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 3.34995260896214064e-01 3.34995260896214064e-01 8.34995260896214120e-01 3 8.34995260896214120e-01 3.34995260896214064e-01 3.34995260896214064e-01 512 0 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 6.57679335789553921e-04 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 1.23299243429797717e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 2.31156775088720750e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 4.33364010865488949e-03 0 0 2 0 0 0 0 0 216 1.24999999999999944e-01 0.00000000000000000e+00 1.24999999999999972e-01 0.00000000000000000e+00 1.24999999999999972e-01 0.00000000000000000e+00 1.24999999999999958e-01 0.00000000000000000e+00 1.24999999999999931e-01 0.00000000000000000e+00 1.24999999999999986e-01 0.00000000000000000e+00 1.24999999999999972e-01 0.00000000000000000e+00 1.25000000000000000e-01 0.00000000000000000e+00 -3.52365706057788941e-19 3.97884220081096279e-02 -2.27682456221955931e-18 3.97884220081096210e-02 -4.17417836406919207e-18 3.97884220081096279e-02 1.08420217248550443e-18 3.97884220081096626e-02 -9.39190131915568216e-18 -3.97884220081095655e-02 -2.43945488809238498e-18 -3.97884220081095794e-02 6.53231808922516421e-18 -3.97884220081095863e-02 6.58652819784943944e-18 -3.97884220081095932e-02 1.33479412390903504e-04 2.00537318789996422e-02 1.33479412390905211e-04 2.00537318789996595e-02 1.33479412390908789e-04 2.00537318789996456e-02 1.33479412390904181e-04 2.00537318789996491e-02 1.33479412391012331e-04 -2.00537318789995866e-02 1.33479412391013469e-04 -2.00537318789995832e-02 1.33479412390986743e-04 -2.00537318789995762e-02 1.33479412391004199e-04 -2.00537318789995901e-02 -6.23416249179165050e-19 3.97884220081096626e-02 -1.51788304147970621e-18 3.97884220081096487e-02 4.06575814682064163e-19 -3.97884220081095932e-02 2.33103467084383453e-18 -3.97884220081096002e-02 6.91178884959509077e-19 3.97884220081096071e-02 2.05998412772245842e-18 3.97884220081096487e-02 1.54498809579184382e-18 -3.97884220081096210e-02 -1.19262238973405488e-18 -3.97884220081096140e-02 -1.26649482071633651e-02 -3.08997619158368764e-18 -1.26649482071633703e-02 -3.25260651745651330e-18 1.26649482071633738e-02 1.13841228110977966e-18 1.26649482071633651e-02 6.83047368665867793e-18 1.26649482071633790e-02 3.55076211489002702e-18 1.26649482071633738e-02 1.73472347597680709e-18 -1.26649482071633634e-02 4.97377746627725159e-18 -1.26649482071633564e-02 8.89045781438113636e-18 -6.38325077471294574e-03 4.24874815168267656e-05 -6.38325077471294921e-03 4.24874815168262710e-05 6.38325077471295962e-03 -4.24874815168392678e-05 6.38325077471296222e-03 -4.24874815168380549e-05 6.38325077471293533e-03 4.24874815168508417e-05 6.38325077471293013e-03 4.24874815168537894e-05 -6.38325077471290931e-03 -4.24874815168442281e-05 -6.38325077471291365e-03 -4.24874815168452513e-05 1.33479412390940909e-04 2.00537318789996595e-02 1.33479412390939472e-04 2.00537318789996560e-02 1.33479412390981106e-04 -2.00537318789995971e-02 1.33479412391005012e-04 -2.00537318789996005e-02 1.33479412390913018e-04 2.00537318789996560e-02 1.33479412390898110e-04 2.00537318789996560e-02 1.33479412390967119e-04 -2.00537318789995866e-02 1.33479412390963325e-04 -2.00537318789995866e-02 -6.38325077471294400e-03 4.24874815168262506e-05 -6.38325077471294054e-03 4.24874815168263658e-05 6.38325077471293360e-03 4.24874815168628492e-05 6.38325077471293880e-03 4.24874815168620835e-05 6.38325077471296656e-03 -4.24874815168440383e-05 6.38325077471296048e-03 -4.24874815168451293e-05 -6.38325077471290497e-03 -4.24874815168387935e-05 -6.38325077471290758e-03 -4.24874815168570826e-05 -3.21707476417017711e-03 4.28281655592655333e-05 -3.21707476417018145e-03 4.28281655592529023e-05 3.21735983222671195e-03 1.10859672136642828e-17 3.21735983222671369e-03 9.43255890062388858e-18 3.21735983222670935e-03 8.48388199969907220e-18 3.21735983222671109e-03 9.10729824887823725e-18 -3.21707476417013504e-03 -4.28281655592915541e-05 -3.21707476417013982e-03 -4.28281655592949694e-05 -3.17129135452010047e-18 3.97884220081096140e-02 -2.16840434497100887e-19 -3.97884220081096002e-02 -3.87602276663567835e-18 3.97884220081096349e-02 -5.96311194867027439e-19 -3.97884220081096140e-02 -2.98155597433513719e-18 3.97884220081096279e-02 7.04731412115577882e-19 -3.97884220081096002e-02 -1.49755425074560300e-18 3.97884220081096557e-02 1.89735380184963276e-18 -3.97884220081096140e-02 -1.26649482071633703e-02 -5.14996031930614606e-18 1.26649482071633721e-02 1.73472347597680709e-18 -1.26649482071633721e-02 -2.76471553983803631e-18 1.26649482071633686e-02 3.57786716920216463e-18 1.26649482071633755e-02 7.56231015308639343e-18 -1.26649482071633426e-02 1.17093834628434479e-17 1.26649482071633738e-02 6.32903018188413213e-18 -1.26649482071633495e-02 4.44522890719056818e-18 -6.38325077471294487e-03 4.24874815168318072e-05 6.38325077471295702e-03 -4.24874815168347277e-05 -6.38325077471294574e-03 4.24874815168295304e-05 6.38325077471295702e-03 -4.24874815168399522e-05 6.38325077471293360e-03 4.24874815168548600e-05 -6.38325077471291278e-03 -4.24874815168488020e-05 6.38325077471293620e-03 4.24874815168627205e-05 -6.38325077471291365e-03 -4.24874815168433065e-05 -1.26649482071633668e-02 -6.17995238316737527e-18 1.26649482071633703e-02 4.55364912443911862e-18 1.26649482071633703e-02 3.79470760369926552e-18 -1.26649482071633426e-02 8.34835672813838414e-18 -1.26649482071633703e-02 -5.88179678573386155e-18 1.26649482071633703e-02 5.42101086242752217e-18 1.26649482071633703e-02 4.16062583691312327e-18 -1.26649482071633391e-02 7.42678488152570537e-18 4.60785923306339384e-18 -4.03134643181973697e-03 4.55364912443911862e-18 4.03134643181974391e-03 5.25838053655469650e-18 4.03134643181974391e-03 3.14418630020796286e-18 -4.03134643181972396e-03 2.71050543121376109e-19 4.03134643181973784e-03 6.07153216591882483e-18 -4.03134643181973611e-03 8.93111539584934278e-18 -4.03134643181974218e-03 1.31188462870746037e-17 4.03134643181971442e-03 -1.35240787572204731e-05 -2.03183580486297494e-03 1.35240787572288215e-05 2.03183580486297408e-03 1.35240787572314913e-05 2.03183580486296757e-03 -1.35240787572172205e-05 -2.03183580486297147e-03 -1.35240787572360450e-05 2.03183580486296497e-03 1.35240787572351640e-05 -2.03183580486296800e-03 1.35240787572377187e-05 -2.03183580486296887e-03 -1.35240787572207170e-05 2.03183580486296063e-03 -6.38325077471293967e-03 4.24874815168312786e-05 6.38325077471296222e-03 -4.24874815168388748e-05 6.38325077471293793e-03 4.24874815168587225e-05 -6.38325077471290758e-03 -4.24874815168442755e-05 -6.38325077471294140e-03 4.24874815168333251e-05 6.38325077471295875e-03 -4.24874815168449396e-05 6.38325077471293186e-03 4.24874815168554157e-05 -6.38325077471291278e-03 -4.24874815168447363e-05 -1.35240787572288757e-05 -2.03183580486297017e-03 1.35240787572314235e-05 2.03183580486297755e-03 -1.35240787572409645e-05 2.03183580486297061e-03 1.35240787572272494e-05 -2.03183580486296280e-03 1.35240787572293229e-05 2.03183580486297017e-03 -1.35240787572236715e-05 -2.03183580486298102e-03 1.35240787572404360e-05 -2.03183580486296454e-03 -1.35240787572284691e-05 2.03183580486295369e-03 -1.36325210008431293e-05 -1.02401862678754940e-03 1.36325210008386840e-05 1.02401862678754875e-03 -1.70761842166466948e-17 1.02410936605261860e-03 -1.52872506320456125e-17 -1.02410936605260841e-03 -1.88786703284038460e-17 1.02410936605261751e-03 -1.26309553094561267e-17 -1.02410936605261513e-03 1.36325210008242235e-05 -1.02401862678754094e-03 -1.36325210008743001e-05 1.02401862678753661e-03 1.33479412390941505e-04 2.00537318789996526e-02 1.33479412391000838e-04 -2.00537318789995797e-02 1.33479412390937358e-04 2.00537318789996595e-02 1.33479412390989725e-04 -2.00537318789995936e-02 1.33479412390902392e-04 2.00537318789996630e-02 1.33479412390965114e-04 -2.00537318789996075e-02 1.33479412390927980e-04 2.00537318789996595e-02 1.33479412390968095e-04 -2.00537318789995936e-02 -6.38325077471294400e-03 4.24874815168320782e-05 6.38325077471293273e-03 4.24874815168582346e-05 -6.38325077471294140e-03 4.24874815168347277e-05 6.38325077471293967e-03 4.24874815168520953e-05 6.38325077471295788e-03 -4.24874815168398913e-05 -6.38325077471291191e-03 -4.24874815168447363e-05 6.38325077471295528e-03 -4.24874815168428728e-05 -6.38325077471290844e-03 -4.24874815168436792e-05 -3.21707476417017451e-03 4.28281655592584317e-05 3.21735983222670892e-03 7.15573433840432926e-18 -3.21707476417017928e-03 4.28281655592480776e-05 3.21735983222671065e-03 8.67361737988403547e-18 3.21735983222670675e-03 8.56519716263548503e-18 -3.21707476417014762e-03 -4.28281655592988725e-05 3.21735983222670328e-03 1.01643953670516041e-17 -3.21707476417014979e-03 -4.28281655592971378e-05 -6.38325077471294227e-03 4.24874815168299708e-05 6.38325077471293099e-03 4.24874815168658444e-05 6.38325077471296048e-03 -4.24874815168242178e-05 -6.38325077471291451e-03 -4.24874815168421478e-05 -6.38325077471293793e-03 4.24874815168316242e-05 6.38325077471293620e-03 4.24874815168549007e-05 6.38325077471295875e-03 -4.24874815168345787e-05 -6.38325077471291105e-03 -4.24874815168555377e-05 -1.35240787572247286e-05 -2.03183580486296844e-03 -1.35240787572397719e-05 2.03183580486297191e-03 1.35240787572300276e-05 2.03183580486298188e-03 1.35240787572288757e-05 -2.03183580486296063e-03 1.35240787572286588e-05 2.03183580486296714e-03 1.35240787572368446e-05 -2.03183580486296627e-03 -1.35240787572270393e-05 -2.03183580486297885e-03 -1.35240787572288486e-05 2.03183580486295586e-03 -1.36325210008455416e-05 -1.02401862678754398e-03 -1.66967134562767683e-17 1.02410936605261708e-03 1.36325210008310675e-05 1.02401862678754983e-03 -1.51246203061727869e-17 -1.02410936605260515e-03 -1.47587020729589291e-17 1.02410936605262055e-03 1.36325210008246978e-05 -1.02401862678754051e-03 -1.22176032311960281e-17 -1.02410936605261817e-03 -1.36325210008754385e-05 1.02401862678754051e-03 -3.21707476417018405e-03 4.28281655592567512e-05 3.21735983222670979e-03 7.15573433840432926e-18 3.21735983222671152e-03 8.91756286869327397e-18 -3.21707476417014459e-03 -4.28281655592897652e-05 -3.21707476417018102e-03 4.28281655592612507e-05 3.21735983222671629e-03 9.10729824887823725e-18 3.21735983222671326e-03 9.08019319456609963e-18 -3.21707476417014415e-03 -4.28281655592982220e-05 -1.36325210008476558e-05 -1.02401862678754094e-03 -1.21430643318376497e-17 1.02410936605261188e-03 -1.26309553094561267e-17 1.02410936605261058e-03 1.36325210008334799e-05 -1.02401862678754138e-03 1.36325210008411641e-05 1.02401862678754094e-03 3.25260651745651330e-19 -1.02410936605262706e-03 2.20228566286118088e-18 -1.02410936605262597e-03 -1.36325210008537815e-05 1.02401862678752642e-03 -1.03062223850791212e-05 -5.16069104615940878e-04 3.43561039885253994e-06 5.16160571469903725e-04 3.43561039884451684e-06 5.16160571469901665e-04 3.43561039885004627e-06 -5.16160571469894617e-04 3.43561039886246039e-06 5.16160571469894184e-04 3.43561039887639239e-06 -5.16160571469919771e-04 3.43561039888150169e-06 -5.16160571469918036e-04 -1.03062223850500104e-05 5.16069104615923206e-04 0 0 2 27 8 729 4.62962962962963458e-03 0.00000000000000000e+00 4.62962962962963284e-03 0.00000000000000000e+00 4.62962962962963284e-03 0.00000000000000000e+00 4.62962962962963718e-03 0.00000000000000000e+00 4.62962962962963197e-03 0.00000000000000000e+00 4.62962962962963891e-03 0.00000000000000000e+00 4.62962962962963631e-03 0.00000000000000000e+00 4.62962962962963978e-03 0.00000000000000000e+00 1.85185185185185106e-02 0.00000000000000000e+00 1.85185185185185244e-02 0.00000000000000000e+00 1.85185185185185175e-02 0.00000000000000000e+00 1.85185185185185210e-02 0.00000000000000000e+00 1.85185185185185140e-02 0.00000000000000000e+00 1.85185185185185210e-02 0.00000000000000000e+00 1.85185185185185210e-02 0.00000000000000000e+00 1.85185185185185036e-02 0.00000000000000000e+00 1.85185185185185140e-02 0.00000000000000000e+00 1.85185185185185071e-02 0.00000000000000000e+00 1.85185185185185036e-02 0.00000000000000000e+00 1.85185185185185071e-02 0.00000000000000000e+00 7.40740740740740561e-02 0.00000000000000000e+00 7.40740740740741255e-02 0.00000000000000000e+00 7.40740740740740700e-02 0.00000000000000000e+00 7.40740740740741394e-02 0.00000000000000000e+00 7.40740740740740422e-02 0.00000000000000000e+00 7.40740740740741255e-02 0.00000000000000000e+00 2.96296296296296835e-01 0.00000000000000000e+00 2.81465216025196096e-03 4.42093577867884446e-03 2.81465216025195879e-03 4.42093577867884620e-03 2.81465216025195922e-03 4.42093577867884880e-03 2.81465216025195966e-03 4.42093577867884620e-03 2.81465216025195966e-03 -4.42093577867885314e-03 2.81465216025196139e-03 -4.42093577867885227e-03 2.81465216025196009e-03 -4.42093577867884880e-03 2.81465216025195706e-03 -4.42093577867885053e-03 1.12586086410078317e-02 1.76837431147153744e-02 1.12586086410078248e-02 1.76837431147153813e-02 1.12586086410078386e-02 1.76837431147153744e-02 1.12586086410078265e-02 1.76837431147153917e-02 1.12586086410078404e-02 -1.76837431147153709e-02 1.12586086410078404e-02 -1.76837431147153917e-02 1.12586086410078334e-02 -1.76837431147153709e-02 1.12586086410078369e-02 -1.76837431147153709e-02 -5.62930432050391671e-03 2.53432257818486661e-18 -5.62930432050391845e-03 2.76471553983803631e-18 -5.62930432050392192e-03 2.13452302708083685e-18 -5.62930432050392192e-03 1.68051336735253187e-18 -2.25172172820156842e-02 1.24141148749590258e-17 -2.25172172820156911e-02 1.23599047663347505e-17 -2.25172172820156807e-02 1.02457105299880169e-17 -2.25172172820156842e-02 1.55854062294791262e-17 4.50344345640313545e-02 7.07349724588614281e-02 4.50344345640313753e-02 -7.07349724588614837e-02 -9.00688691280627229e-02 4.94396190653390022e-17 6.89387659566726395e-04 2.22819243099996091e-03 6.89387659566725744e-04 2.22819243099996091e-03 6.89387659566725744e-04 2.22819243099995831e-03 6.89387659566725744e-04 2.22819243099996005e-03 6.89387659566734418e-04 -2.22819243099995918e-03 6.89387659566735068e-04 -2.22819243099996091e-03 6.89387659566734526e-04 -2.22819243099995875e-03 6.89387659566734418e-04 -2.22819243099995744e-03 2.75755063826689604e-03 8.91276972399982631e-03 2.75755063826689604e-03 8.91276972399983325e-03 2.75755063826690254e-03 8.91276972399982631e-03 2.75755063826689517e-03 8.91276972399983151e-03 2.75755063826692726e-03 -8.91276972399983151e-03 2.75755063826692379e-03 -8.91276972399983498e-03 2.75755063826693594e-03 -8.91276972399982804e-03 2.75755063826692900e-03 -8.91276972399983325e-03 -1.34911322749102849e-03 5.63785129692462306e-18 -1.34911322749103478e-03 7.04731412115577882e-18 -1.34911322749103153e-03 5.73949525059513910e-18 -1.34911322749102828e-03 6.93889390390722838e-18 -5.39645290996411311e-03 2.33103467084383453e-17 -5.39645290996411224e-03 2.53703308361608038e-17 -5.39645290996410617e-03 2.19008838842071896e-17 -5.39645290996411137e-03 2.18195687212707767e-17 1.10302025530675737e-02 3.56510788959993122e-02 1.10302025530676449e-02 -3.56510788959993399e-02 -2.15858116398563379e-02 9.58434720477185920e-17 2.81465216025196226e-03 4.42093577867884620e-03 2.81465216025196053e-03 4.42093577867884707e-03 2.81465216025196009e-03 -4.42093577867884446e-03 2.81465216025196139e-03 -4.42093577867884793e-03 2.81465216025196139e-03 4.42093577867885140e-03 2.81465216025196313e-03 4.42093577867884620e-03 2.81465216025196009e-03 -4.42093577867884620e-03 2.81465216025196009e-03 -4.42093577867884793e-03 -5.62930432050392105e-03 2.41234983378024737e-18 -5.62930432050392192e-03 5.04154010205759562e-18 1.12586086410078334e-02 1.76837431147153779e-02 1.12586086410078369e-02 -1.76837431147153744e-02 -5.62930432050391585e-03 2.09386544561263044e-18 -5.62930432050391498e-03 1.68051336735253187e-18 1.12586086410078404e-02 1.76837431147153848e-02 1.12586086410078490e-02 -1.76837431147153779e-02 1.12586086410078317e-02 1.76837431147153744e-02 1.12586086410078248e-02 1.76837431147153813e-02 1.12586086410078404e-02 -1.76837431147153674e-02 1.12586086410078404e-02 -1.76837431147153848e-02 -2.25172172820156634e-02 1.06251812903579435e-17 -2.25172172820156391e-02 1.36609473733173559e-17 4.50344345640313753e-02 7.07349724588614559e-02 4.50344345640313892e-02 -7.07349724588615392e-02 -2.25172172820156738e-02 1.00288700954909160e-17 -2.25172172820156669e-02 1.01643953670516041e-17 -9.00688691280626813e-02 5.81132364452230377e-17 -2.51043977721420765e-03 5.37554726199082795e-03 -2.51043977721420938e-03 5.37554726199082535e-03 5.93285902756137112e-03 2.29715335295366252e-18 5.93285902756137285e-03 1.92445885616177037e-18 5.93285902756137372e-03 2.00238588730916600e-18 5.93285902756137372e-03 2.25649577148545610e-18 -2.51043977721420244e-03 -5.37554726199083142e-03 -2.51043977721420244e-03 -5.37554726199083403e-03 -3.42241925034716217e-03 -5.37554726199082709e-03 -3.42241925034716520e-03 -5.37554726199083142e-03 -1.00417591088568306e-02 2.15021890479633083e-02 2.37314361102454706e-02 7.75204553327135670e-18 -3.42241925034715740e-03 5.37554726199083316e-03 -3.42241925034715870e-03 5.37554726199083576e-03 2.37314361102454636e-02 9.37834879199961335e-18 -1.00417591088568098e-02 -2.15021890479633292e-02 -3.42241925034716217e-03 -5.37554726199082969e-03 -3.42241925034716303e-03 -5.37554726199083142e-03 -3.42241925034716087e-03 5.37554726199083489e-03 -3.42241925034715913e-03 5.37554726199083750e-03 6.84483850069434081e-03 -8.89045781438113636e-18 6.84483850069434775e-03 -7.58941520739853104e-18 -1.36896770013886521e-02 -2.15021890479633430e-02 -1.36896770013886556e-02 2.15021890479633465e-02 -1.36896770013886712e-02 -2.15021890479633430e-02 -1.36896770013886435e-02 2.15021890479633708e-02 2.73793540027773043e-02 -3.18755438710738304e-17 -1.70862678174353295e-03 2.01297424512872835e-03 -1.70862678174353339e-03 2.01297424512873009e-03 2.54687373473176052e-03 6.96351183079584372e-04 2.54687373473176226e-03 6.96351183079583829e-04 2.54687373473176356e-03 -6.96351183079577324e-04 2.54687373473176356e-03 -6.96351183079577541e-04 -1.70862678174352515e-03 -2.01297424512873356e-03 -1.70862678174352601e-03 -2.01297424512873529e-03 -8.38246952988226917e-04 -2.70932542820831327e-03 -8.38246952988228218e-04 -2.70932542820831413e-03 -6.83450712697413528e-03 8.05189698051490300e-03 1.01874949389270698e-02 2.78540473231833705e-03 -8.38246952988235482e-04 2.70932542820831804e-03 -8.38246952988239060e-04 2.70932542820831804e-03 1.01874949389270646e-02 -2.78540473231830756e-03 -6.83450712697409972e-03 -8.05189698051493596e-03 -8.20213443399341199e-04 -1.28829807437125395e-03 -8.20213443399340656e-04 -1.28829807437125504e-03 -8.20213443399322225e-04 1.28829807437125742e-03 -8.20213443399323960e-04 1.28829807437125937e-03 1.64042688679867784e-03 -8.57536155800253663e-18 1.64042688679867416e-03 -7.23704950134074210e-18 -3.28085377359737477e-03 -5.15319229748503228e-03 -3.28085377359730842e-03 5.15319229748503315e-03 -3.35298781195290897e-03 -1.08373017128332774e-02 -3.35298781195295407e-03 1.08373017128332600e-02 6.56170754719473306e-03 -2.97681258983051311e-17 6.89387659566723576e-04 2.22819243099995918e-03 6.89387659566727371e-04 2.22819243099995658e-03 6.89387659566733008e-04 -2.22819243099995571e-03 6.89387659566733225e-04 -2.22819243099995788e-03 6.89387659566726503e-04 2.22819243099995831e-03 6.89387659566726286e-04 2.22819243099995875e-03 6.89387659566732575e-04 -2.22819243099996048e-03 6.89387659566733334e-04 -2.22819243099995788e-03 -1.34911322749102676e-03 7.20994444702860449e-18 -1.34911322749102871e-03 5.96311194867027439e-18 2.75755063826689560e-03 8.91276972399981937e-03 2.75755063826692510e-03 -8.91276972399982978e-03 -1.34911322749102763e-03 7.78592685116152872e-18 -1.34911322749102372e-03 6.01732205729454961e-18 2.75755063826689994e-03 8.91276972399983151e-03 2.75755063826692640e-03 -8.91276972399983151e-03 2.75755063826690081e-03 8.91276972399982978e-03 2.75755063826690168e-03 8.91276972399982284e-03 2.75755063826692336e-03 -8.91276972399982111e-03 2.75755063826692813e-03 -8.91276972399983325e-03 -5.39645290996410964e-03 2.45029690981724002e-17 -5.39645290996411398e-03 2.14672030152129878e-17 1.10302025530675876e-02 3.56510788959993191e-02 1.10302025530676917e-02 -3.56510788959992775e-02 -5.39645290996411051e-03 2.39066579033053728e-17 -5.39645290996412352e-03 2.44758640438602626e-17 -2.15858116398563657e-02 9.80118763926896008e-17 -1.70862678174353274e-03 2.01297424512872792e-03 -1.70862678174353295e-03 2.01297424512873009e-03 2.54687373473176399e-03 -6.96351183079577107e-04 2.54687373473176486e-03 -6.96351183079577649e-04 2.54687373473176095e-03 6.96351183079583829e-04 2.54687373473176095e-03 6.96351183079584046e-04 -1.70862678174352536e-03 -2.01297424512873312e-03 -1.70862678174352710e-03 -2.01297424512873573e-03 -8.20213443399341524e-04 -1.28829807437125178e-03 -8.20213443399341957e-04 -1.28829807437125048e-03 -6.83450712697413702e-03 8.05189698051492729e-03 1.01874949389270525e-02 -2.78540473231831060e-03 -8.20213443399326237e-04 1.28829807437126219e-03 -8.20213443399326562e-04 1.28829807437126154e-03 1.01874949389270456e-02 2.78540473231833749e-03 -6.83450712697409972e-03 -8.05189698051495852e-03 -8.38246952988226158e-04 -2.70932542820831370e-03 -8.38246952988228435e-04 -2.70932542820831717e-03 -8.38246952988241554e-04 2.70932542820831847e-03 -8.38246952988241228e-04 2.70932542820832021e-03 1.64042688679868175e-03 -6.71527720583209309e-18 1.64042688679868305e-03 -7.23704950134074210e-18 -3.35298781195291027e-03 -1.08373017128332617e-02 -3.35298781195294757e-03 1.08373017128332756e-02 -3.28085377359737390e-03 -5.15319229748502448e-03 -3.28085377359731145e-03 5.15319229748504009e-03 6.56170754719468709e-03 -2.60953910390104848e-17 -9.69750611510963845e-04 6.63590173710823213e-04 -9.69750611510964713e-04 6.63590173710824406e-04 1.17506092062133168e-03 4.61124736485241105e-18 1.17506092062133168e-03 3.84214144874550634e-18 1.17506092062133038e-03 4.11319199186688245e-18 1.17506092062133146e-03 4.11319199186688245e-18 -9.69750611510957448e-04 -6.63590173710833730e-04 -9.69750611510956906e-04 -6.63590173710835139e-04 -2.00893394244360657e-04 -6.49314118524403844e-04 -2.00893394244361660e-04 -6.49314118524403410e-04 -3.87900244604385365e-03 2.65436069484329762e-03 4.70024368248532151e-03 1.54905385393866446e-17 -2.00893394244353501e-04 6.49314118524405254e-04 -2.00893394244356049e-04 6.49314118524404278e-04 4.70024368248532064e-03 1.97934659114384903e-17 -3.87900244604383109e-03 -2.65436069484333492e-03 -2.00893394244360034e-04 -6.49314118524403627e-04 -2.00893394244360305e-04 -6.49314118524403410e-04 -2.00893394244355480e-04 6.49314118524402326e-04 -2.00893394244352472e-04 6.49314118524402868e-04 3.93143004127714975e-04 -6.61363325216157705e-18 3.93143004127721263e-04 -7.80625564189563192e-18 -8.03573576977445123e-04 -2.59725647409761061e-03 -8.03573576977410537e-04 2.59725647409761928e-03 -8.03573576977446640e-04 -2.59725647409761321e-03 -8.03573576977414765e-04 2.59725647409762492e-03 1.57257201651088093e-03 -2.14672030152129878e-17 2.81465216025196096e-03 4.42093577867884793e-03 2.81465216025196053e-03 -4.42093577867884360e-03 2.81465216025196053e-03 4.42093577867884793e-03 2.81465216025196139e-03 -4.42093577867884533e-03 2.81465216025195966e-03 4.42093577867885053e-03 2.81465216025196269e-03 -4.42093577867885140e-03 2.81465216025196269e-03 4.42093577867884707e-03 2.81465216025196096e-03 -4.42093577867884880e-03 1.12586086410078317e-02 1.76837431147153744e-02 1.12586086410078404e-02 -1.76837431147153709e-02 -5.62930432050391932e-03 2.10064170919066484e-18 -5.62930432050391932e-03 3.70661617718481828e-18 1.12586086410078404e-02 1.76837431147153917e-02 1.12586086410078404e-02 -1.76837431147153883e-02 -5.62930432050391411e-03 2.60886147754324504e-18 -5.62930432050392192e-03 3.33392168039292613e-18 1.12586086410078352e-02 1.76837431147153744e-02 1.12586086410078369e-02 -1.76837431147153744e-02 1.12586086410078456e-02 1.76837431147153848e-02 1.12586086410078404e-02 -1.76837431147153813e-02 4.50344345640313962e-02 7.07349724588614698e-02 4.50344345640314031e-02 -7.07349724588614975e-02 -2.25172172820156634e-02 1.00830802041151912e-17 -2.25172172820156426e-02 1.11672823766006957e-17 -2.25172172820156703e-02 1.30646361784503284e-17 -2.25172172820156669e-02 1.02999206386122921e-17 -9.00688691280626952e-02 5.94142790522056430e-17 -2.51043977721420938e-03 5.37554726199083056e-03 5.93285902756137112e-03 2.22261445359528409e-18 -2.51043977721420808e-03 5.37554726199083056e-03 5.93285902756137372e-03 2.35136346157793774e-18 5.93285902756137545e-03 2.12266456581927665e-18 -2.51043977721420548e-03 -5.37554726199082275e-03 5.93285902756137372e-03 2.26242500211623621e-18 -2.51043977721420375e-03 -5.37554726199082882e-03 -1.00417591088568254e-02 2.15021890479633222e-02 2.37314361102454636e-02 1.05709711817336682e-17 -3.42241925034716477e-03 -5.37554726199083056e-03 -3.42241925034716434e-03 -5.37554726199082882e-03 2.37314361102454602e-02 1.01711716306296385e-17 -1.00417591088568098e-02 -2.15021890479633153e-02 -3.42241925034715956e-03 5.37554726199083229e-03 -3.42241925034716087e-03 5.37554726199083229e-03 -3.42241925034716737e-03 -5.37554726199082795e-03 -3.42241925034716173e-03 5.37554726199083403e-03 -3.42241925034716217e-03 -5.37554726199082882e-03 -3.42241925034716217e-03 5.37554726199083576e-03 -1.36896770013886643e-02 -2.15021890479633396e-02 -1.36896770013886469e-02 2.15021890479633430e-02 6.84483850069433561e-03 -8.78203759713258592e-18 6.84483850069434862e-03 -7.53520509877425582e-18 -1.36896770013886625e-02 -2.15021890479633569e-02 -1.36896770013886573e-02 2.15021890479633777e-02 2.73793540027773112e-02 -2.68882138776405100e-17 -1.70862678174353317e-03 2.01297424512872965e-03 2.54687373473176182e-03 6.96351183079584588e-04 -1.70862678174353447e-03 2.01297424512873096e-03 2.54687373473175922e-03 6.96351183079584046e-04 2.54687373473176529e-03 -6.96351183079576565e-04 -1.70862678174352536e-03 -2.01297424512873703e-03 2.54687373473176312e-03 -6.96351183079577433e-04 -1.70862678174352666e-03 -2.01297424512873789e-03 -6.83450712697413615e-03 8.05189698051490994e-03 1.01874949389270525e-02 2.78540473231833575e-03 -8.38246952988226917e-04 -2.70932542820831197e-03 -8.38246952988227784e-04 -2.70932542820831153e-03 1.01874949389270664e-02 -2.78540473231831103e-03 -6.83450712697410232e-03 -8.05189698051493770e-03 -8.38246952988236892e-04 2.70932542820831760e-03 -8.38246952988236783e-04 2.70932542820831760e-03 -8.20213443399340982e-04 -1.28829807437125200e-03 -8.20213443399326128e-04 1.28829807437125894e-03 -8.20213443399343042e-04 -1.28829807437125222e-03 -8.20213443399326020e-04 1.28829807437125959e-03 -3.28085377359736783e-03 -5.15319229748502361e-03 -3.28085377359731319e-03 5.15319229748503489e-03 1.64042688679868348e-03 -6.99310401253150360e-18 1.64042688679868305e-03 -5.15080735225340036e-18 -3.35298781195291417e-03 -1.08373017128332721e-02 -3.35298781195296188e-03 1.08373017128332635e-02 6.56170754719473046e-03 -2.49366499671666020e-17 -2.51043977721420722e-03 5.37554726199083056e-03 5.93285902756137112e-03 2.00577401909818320e-18 5.93285902756137285e-03 2.41573796556926457e-18 -2.51043977721420375e-03 -5.37554726199082969e-03 -2.51043977721420895e-03 5.37554726199082449e-03 5.93285902756137632e-03 2.24971950790742170e-18 5.93285902756137545e-03 2.18788610275785778e-18 -2.51043977721420331e-03 -5.37554726199082622e-03 -3.42241925034716477e-03 -5.37554726199082795e-03 -3.42241925034716087e-03 5.37554726199083229e-03 -3.42241925034716043e-03 -5.37554726199083403e-03 -3.42241925034716000e-03 5.37554726199083403e-03 -3.42241925034716303e-03 -5.37554726199082795e-03 -3.42241925034716173e-03 5.37554726199083663e-03 -3.42241925034716390e-03 -5.37554726199082535e-03 -3.42241925034716130e-03 5.37554726199083056e-03 -1.00417591088568289e-02 2.15021890479633222e-02 2.37314361102454879e-02 8.61940727125976025e-18 2.37314361102454775e-02 9.46644021851406059e-18 -1.00417591088568167e-02 -2.15021890479633396e-02 -1.36896770013886608e-02 -2.15021890479633396e-02 -1.36896770013886521e-02 2.15021890479633569e-02 -1.36896770013886591e-02 -2.15021890479633257e-02 -1.36896770013886435e-02 2.15021890479633604e-02 6.84483850069433995e-03 -7.58941520739853104e-18 6.84483850069433821e-03 -9.13440330319037486e-18 2.73793540027772800e-02 -3.07913416985883259e-17 -6.65948821592867845e-03 8.70869379353939673e-04 3.60696984733351956e-03 5.66541836887763783e-03 3.60696984733352259e-03 5.66541836887763609e-03 3.60696984733352953e-03 -5.66541836887762568e-03 3.60696984733352346e-03 5.66541836887763262e-03 3.60696984733352996e-03 -5.66541836887763089e-03 3.60696984733352996e-03 -5.66541836887762915e-03 -6.65948821592867498e-03 -8.70869379353946720e-04 3.05251836859515759e-03 -6.53628774823157826e-03 -7.21393969466705906e-03 6.91517698138410797e-18 3.05251836859515759e-03 -6.53628774823157826e-03 -7.21393969466705646e-03 8.15925662266386159e-18 -7.21393969466705559e-03 1.85394336330284987e-18 3.05251836859516323e-03 6.53628774823157045e-03 -7.21393969466705472e-03 6.23839765652792200e-19 3.05251836859516497e-03 6.53628774823156091e-03 3.05251836859515803e-03 -6.53628774823157652e-03 -7.21393969466705125e-03 1.82959116606928873e-18 -7.21393969466706253e-03 2.78589136351939382e-18 3.05251836859515629e-03 6.53628774823157479e-03 4.16142132607189453e-03 6.53628774823156698e-03 4.16142132607190060e-03 -6.53628774823158259e-03 4.16142132607190667e-03 6.53628774823156958e-03 4.16142132607190060e-03 -6.53628774823157999e-03 4.16142132607191188e-03 6.53628774823158086e-03 4.16142132607190147e-03 -6.53628774823157219e-03 -8.32284265214379947e-03 1.87838026383113643e-17 -2.96101870361584283e-03 -4.07787904274920518e-04 8.83448596702765001e-04 2.85542314115083597e-03 8.83448596702764567e-04 2.85542314115083467e-03 2.21337090413717885e-03 -2.00870903287528411e-03 2.21337090413717234e-03 2.00870903287529365e-03 8.83448596702778445e-04 -2.85542314115083684e-03 8.83448596702778662e-04 -2.85542314115083727e-03 -2.96101870361584283e-03 4.07787904274910652e-04 2.07757010691307729e-03 -2.44763523687591394e-03 -3.09681950083994569e-03 -8.46714108275548288e-04 2.07757010691307815e-03 -2.44763523687591264e-03 -3.09681950083994569e-03 -8.46714108275549589e-04 -3.09681950083995306e-03 8.46714108275544168e-04 2.07757010691307469e-03 2.44763523687592435e-03 -3.09681950083995393e-03 8.46714108275543843e-04 2.07757010691307599e-03 2.44763523687592435e-03 7.31563382216005335e-04 -1.56647993388948025e-03 -1.72888529563928594e-03 4.60785923306339384e-18 -1.72888529563927857e-03 5.56331239756624463e-18 7.31563382216022791e-04 1.56647993388948480e-03 9.97321913423274533e-04 1.56647993388947266e-03 9.97321913423266943e-04 -1.56647993388949304e-03 9.97321913423273665e-04 1.56647993388947266e-03 9.97321913423267811e-04 -1.56647993388949261e-03 1.01924939392687968e-03 3.29434934515146927e-03 1.01924939392687773e-03 -3.29434934515145279e-03 -1.99464382684651220e-03 -4.98732999343332040e-18 -1.70862678174353295e-03 2.01297424512872879e-03 2.54687373473176139e-03 6.96351183079584155e-04 2.54687373473176312e-03 -6.96351183079577216e-04 -1.70862678174352536e-03 -2.01297424512873659e-03 -1.70862678174353425e-03 2.01297424512873009e-03 2.54687373473176182e-03 6.96351183079584155e-04 2.54687373473176529e-03 -6.96351183079577649e-04 -1.70862678174352666e-03 -2.01297424512873789e-03 -8.20213443399342391e-04 -1.28829807437125547e-03 -8.20213443399326670e-04 1.28829807437125959e-03 -8.38246952988226483e-04 -2.70932542820831717e-03 -8.38246952988237217e-04 2.70932542820831977e-03 -8.20213443399343909e-04 -1.28829807437125373e-03 -8.20213443399326128e-04 1.28829807437125916e-03 -8.38246952988226375e-04 -2.70932542820831587e-03 -8.38246952988239168e-04 2.70932542820832107e-03 -6.83450712697413615e-03 8.05189698051491341e-03 1.01874949389270438e-02 2.78540473231833705e-03 1.01874949389270508e-02 -2.78540473231830886e-03 -6.83450712697409798e-03 -8.05189698051493596e-03 -3.28085377359736696e-03 -5.15319229748501841e-03 -3.28085377359731015e-03 5.15319229748504876e-03 -3.35298781195290550e-03 -1.08373017128332687e-02 -3.35298781195295971e-03 1.08373017128332652e-02 1.64042688679868348e-03 -7.49962971498957520e-18 1.64042688679868196e-03 -9.36225516600178165e-18 6.56170754719470964e-03 -3.43488800770563873e-17 -2.96101870361584413e-03 -4.07787904274921115e-04 8.83448596702767711e-04 2.85542314115083511e-03 2.21337090413717234e-03 2.00870903287529148e-03 8.83448596702775843e-04 -2.85542314115083120e-03 8.83448596702768904e-04 2.85542314115083641e-03 2.21337090413717798e-03 -2.00870903287528324e-03 8.83448596702779963e-04 -2.85542314115083294e-03 -2.96101870361584500e-03 4.07787904274909785e-04 7.31563382216000456e-04 -1.56647993388948350e-03 -1.72888529563928008e-03 1.08420217248550443e-17 2.07757010691308032e-03 -2.44763523687591437e-03 -3.09681950083996044e-03 8.46714108275545795e-04 -1.72888529563927705e-03 8.60585474410369144e-18 7.31563382216014876e-04 1.56647993388947244e-03 -3.09681950083994439e-03 -8.46714108275552083e-04 2.07757010691307512e-03 2.44763523687592608e-03 2.07757010691307512e-03 -2.44763523687592001e-03 -3.09681950083994656e-03 -8.46714108275550348e-04 -3.09681950083995220e-03 8.46714108275545252e-04 2.07757010691307252e-03 2.44763523687592261e-03 9.97321913423274099e-04 1.56647993388947179e-03 9.97321913423261739e-04 -1.56647993388948372e-03 1.01924939392687036e-03 3.29434934515146364e-03 1.01924939392688272e-03 -3.29434934515147361e-03 9.97321913423278653e-04 1.56647993388948697e-03 9.97321913423268678e-04 -1.56647993388949456e-03 -1.99464382684654039e-03 2.38524477946810975e-18 -1.22325124210550585e-03 -5.22596806315349513e-04 4.41026397524657779e-05 1.32947582920883820e-03 7.14395755869367361e-04 1.12209167507806677e-03 7.14395755869371590e-04 -1.12209167507805875e-03 7.14395755869366277e-04 1.12209167507806656e-03 7.14395755869372024e-04 -1.12209167507806439e-03 4.41026397524751495e-05 -1.32947582920883841e-03 -1.22325124210551106e-03 5.22596806315342032e-04 4.97908294292653104e-04 -5.86597719031621469e-04 -7.42180545563636421e-04 -2.02922623887480218e-04 1.17914860235303668e-03 -8.06879022893489659e-04 -1.42879151173874556e-03 -2.77826806699410511e-18 -7.42180545563636746e-04 2.02922623887490003e-04 4.97908294292652778e-04 5.86597719031615615e-04 -1.42879151173873971e-03 -1.60597446799415344e-18 1.17914860235302779e-03 8.06879022893496924e-04 4.97908294292652236e-04 -5.86597719031622445e-04 -7.42180545563633385e-04 -2.02922623887484012e-04 -7.42180545563637505e-04 2.02922623887486371e-04 4.97908294292650935e-04 5.86597719031620494e-04 2.39017134064896288e-04 3.75420954186462489e-04 2.39017134064888428e-04 -3.75420954186468777e-04 2.44272251270987437e-04 7.89520342919096374e-04 2.44272251270959736e-04 -7.89520342919108843e-04 2.44272251270991124e-04 7.89520342919108084e-04 2.44272251270964236e-04 -7.89520342919107650e-04 -4.78034268129859797e-04 -5.42101086242752217e-18 6.89387659566723251e-04 2.22819243099995528e-03 6.89387659566730515e-04 -2.22819243099995744e-03 6.89387659566726286e-04 2.22819243099995831e-03 6.89387659566732900e-04 -2.22819243099995788e-03 6.89387659566729322e-04 2.22819243099995831e-03 6.89387659566733551e-04 -2.22819243099995831e-03 6.89387659566726178e-04 2.22819243099996091e-03 6.89387659566732466e-04 -2.22819243099996091e-03 2.75755063826689517e-03 8.91276972399982284e-03 2.75755063826692206e-03 -8.91276972399983325e-03 -1.34911322749102351e-03 6.23416249179165050e-18 -1.34911322749102502e-03 6.05120337518472162e-18 2.75755063826689734e-03 8.91276972399983151e-03 2.75755063826692900e-03 -8.91276972399983672e-03 -1.34911322749102437e-03 6.32903018188413213e-18 -1.34911322749102502e-03 5.62768690155757145e-18 2.75755063826689691e-03 8.91276972399983151e-03 2.75755063826692466e-03 -8.91276972399982804e-03 2.75755063826689474e-03 8.91276972399982804e-03 2.75755063826692249e-03 -8.91276972399983151e-03 1.10302025530675998e-02 3.56510788959993122e-02 1.10302025530676882e-02 -3.56510788959993052e-02 -5.39645290996411831e-03 2.32019264911897949e-17 -5.39645290996411137e-03 2.39337629576175104e-17 -5.39645290996410010e-03 2.37982376860568223e-17 -5.39645290996411484e-03 2.37711326317446847e-17 -2.15858116398563692e-02 9.49761103097301884e-17 -1.70862678174353360e-03 2.01297424512873096e-03 2.54687373473176182e-03 -6.96351183079577324e-04 -1.70862678174353339e-03 2.01297424512873096e-03 2.54687373473176529e-03 -6.96351183079577433e-04 2.54687373473175879e-03 6.96351183079584372e-04 -1.70862678174352623e-03 -2.01297424512873659e-03 2.54687373473176226e-03 6.96351183079584372e-04 -1.70862678174352710e-03 -2.01297424512873703e-03 -6.83450712697413702e-03 8.05189698051492209e-03 1.01874949389270560e-02 -2.78540473231831103e-03 -8.20213443399340656e-04 -1.28829807437125373e-03 -8.20213443399342283e-04 -1.28829807437125243e-03 1.01874949389270438e-02 2.78540473231833662e-03 -6.83450712697410145e-03 -8.05189698051495158e-03 -8.20213443399327104e-04 1.28829807437126154e-03 -8.20213443399326020e-04 1.28829807437126046e-03 -8.38246952988226375e-04 -2.70932542820831630e-03 -8.38246952988236783e-04 2.70932542820831760e-03 -8.38246952988226592e-04 -2.70932542820831283e-03 -8.38246952988239494e-04 2.70932542820832064e-03 -3.35298781195291547e-03 -1.08373017128332652e-02 -3.35298781195295320e-03 1.08373017128332721e-02 1.64042688679868305e-03 -6.12574227454310005e-18 1.64042688679868435e-03 -8.04935409775761612e-18 -3.28085377359736870e-03 -5.15319229748501754e-03 -3.28085377359730538e-03 5.15319229748504529e-03 6.56170754719469229e-03 -3.05745012640912250e-17 -9.69750611510964496e-04 6.63590173710824948e-04 1.17506092062133103e-03 3.95733792957209118e-18 -9.69750611510965580e-04 6.63590173710823972e-04 1.17506092062133059e-03 3.93023287525995357e-18 1.17506092062133125e-03 4.23685880216601030e-18 -9.69750611510957232e-04 -6.63590173710832320e-04 1.17506092062133016e-03 4.00053660988206050e-18 -9.69750611510957665e-04 -6.63590173710834272e-04 -3.87900244604385885e-03 2.65436069484329676e-03 4.70024368248532325e-03 1.73472347597680709e-17 -2.00893394244361389e-04 -6.49314118524404712e-04 -2.00893394244361091e-04 -6.49314118524403953e-04 4.70024368248532672e-03 1.76860479386697911e-17 -3.87900244604383066e-03 -2.65436069484333232e-03 -2.00893394244354044e-04 6.49314118524404495e-04 -2.00893394244353285e-04 6.49314118524404278e-04 -2.00893394244360278e-04 -6.49314118524402326e-04 -2.00893394244352092e-04 6.49314118524408615e-04 -2.00893394244362555e-04 -6.49314118524405254e-04 -2.00893394244353745e-04 6.49314118524403085e-04 -8.03573576977448809e-04 -2.59725647409761451e-03 -8.03573576977409561e-04 2.59725647409761624e-03 3.93143004127715734e-04 -6.83047368665867793e-18 3.93143004127721480e-04 -4.90601483049690756e-18 -8.03573576977440894e-04 -2.59725647409761451e-03 -8.03573576977422029e-04 2.59725647409761538e-03 1.57257201651090240e-03 -2.16840434497100887e-17 -1.70862678174353295e-03 2.01297424512872705e-03 2.54687373473176312e-03 -6.96351183079576999e-04 2.54687373473176052e-03 6.96351183079583938e-04 -1.70862678174352623e-03 -2.01297424512873746e-03 -1.70862678174353339e-03 2.01297424512873052e-03 2.54687373473176703e-03 -6.96351183079577758e-04 2.54687373473176095e-03 6.96351183079584697e-04 -1.70862678174352623e-03 -2.01297424512873789e-03 -8.38246952988226592e-04 -2.70932542820831283e-03 -8.38246952988239819e-04 2.70932542820831717e-03 -8.20213443399341957e-04 -1.28829807437125482e-03 -8.20213443399326779e-04 1.28829807437125482e-03 -8.38246952988225182e-04 -2.70932542820831674e-03 -8.38246952988237976e-04 2.70932542820832107e-03 -8.20213443399342933e-04 -1.28829807437125677e-03 -8.20213443399328513e-04 1.28829807437126111e-03 -6.83450712697413181e-03 8.05189698051491168e-03 1.01874949389270525e-02 -2.78540473231831147e-03 1.01874949389270403e-02 2.78540473231833705e-03 -6.83450712697409712e-03 -8.05189698051494637e-03 -3.35298781195290984e-03 -1.08373017128332704e-02 -3.35298781195296188e-03 1.08373017128332669e-02 -3.28085377359737217e-03 -5.15319229748501841e-03 -3.28085377359730538e-03 5.15319229748504096e-03 1.64042688679868261e-03 -7.21163851292311309e-18 1.64042688679868370e-03 -7.63261388770850036e-18 6.56170754719471137e-03 -2.73286710102127461e-17 -2.96101870361584587e-03 -4.07787904274920464e-04 2.21337090413717148e-03 2.00870903287529278e-03 8.83448596702764350e-04 2.85542314115083641e-03 8.83448596702776385e-04 -2.85542314115083207e-03 8.83448596702768037e-04 2.85542314115083684e-03 8.83448596702779095e-04 -2.85542314115083381e-03 2.21337090413717711e-03 -2.00870903287528497e-03 -2.96101870361584196e-03 4.07787904274908321e-04 2.07757010691308119e-03 -2.44763523687591524e-03 -3.09681950083995957e-03 8.46714108275545578e-04 7.31563382216000348e-04 -1.56647993388948112e-03 -1.72888529563927705e-03 1.09097843606353884e-17 -3.09681950083994482e-03 -8.46714108275551107e-04 2.07757010691307469e-03 2.44763523687592435e-03 -1.72888529563927770e-03 8.67361737988403547e-18 7.31563382216014876e-04 1.56647993388947049e-03 2.07757010691307512e-03 -2.44763523687591871e-03 -3.09681950083995090e-03 8.46714108275547096e-04 -3.09681950083994352e-03 -8.46714108275551432e-04 2.07757010691307252e-03 2.44763523687592521e-03 1.01924939392687361e-03 3.29434934515146580e-03 1.01924939392688293e-03 -3.29434934515146927e-03 9.97321913423272581e-04 1.56647993388947570e-03 9.97321913423258920e-04 -1.56647993388948892e-03 9.97321913423282122e-04 1.56647993388948350e-03 9.97321913423268027e-04 -1.56647993388949348e-03 -1.99464382684654690e-03 8.45677694538693459e-18 -1.22325124210550563e-03 -5.22596806315349729e-04 7.14395755869366494e-04 1.12209167507806677e-03 4.41026397524665301e-05 1.32947582920883668e-03 7.14395755869371698e-04 -1.12209167507806005e-03 7.14395755869366711e-04 1.12209167507806721e-03 4.41026397524745125e-05 -1.32947582920883885e-03 7.14395755869372349e-04 -1.12209167507806395e-03 -1.22325124210551192e-03 5.22596806315341164e-04 1.17914860235303668e-03 -8.06879022893487816e-04 -1.42879151173874405e-03 -2.05998412772245842e-18 4.97908294292655164e-04 -5.86597719031619301e-04 -7.42180545563633819e-04 -2.02922623887478835e-04 -1.42879151173874058e-03 -1.21972744404619249e-18 1.17914860235302605e-03 8.06879022893496815e-04 -7.42180545563637831e-04 2.02922623887491141e-04 4.97908294292649634e-04 5.86597719031614747e-04 4.97908294292652453e-04 -5.86597719031621686e-04 -7.42180545563636855e-04 2.02922623887487157e-04 -7.42180545563634253e-04 -2.02922623887484283e-04 4.97908294292651911e-04 5.86597719031619626e-04 2.44272251270991774e-04 7.89520342919100494e-04 2.44272251270964886e-04 -7.89520342919105265e-04 2.39017134064896153e-04 3.75420954186467747e-04 2.39017134064886287e-04 -3.75420954186464061e-04 2.44272251270990040e-04 7.89520342919108409e-04 2.44272251270961688e-04 -7.89520342919108301e-04 -4.78034268129858605e-04 -1.73472347597680709e-18 -9.69750611510963628e-04 6.63590173710825490e-04 1.17506092062132994e-03 4.33680868994201774e-18 1.17506092062133103e-03 4.44184077540155098e-18 -9.69750611510957882e-04 -6.63590173710835464e-04 -9.69750611510965146e-04 6.63590173710823863e-04 1.17506092062133081e-03 4.28937484489577692e-18 1.17506092062133016e-03 4.14283814502078296e-18 -9.69750611510957991e-04 -6.63590173710834163e-04 -2.00893394244361660e-04 -6.49314118524403194e-04 -2.00893394244353691e-04 6.49314118524402760e-04 -2.00893394244360034e-04 -6.49314118524404495e-04 -2.00893394244352444e-04 6.49314118524404169e-04 -2.00893394244360711e-04 -6.49314118524403085e-04 -2.00893394244353447e-04 6.49314118524404928e-04 -2.00893394244362826e-04 -6.49314118524403844e-04 -2.00893394244352851e-04 6.49314118524403194e-04 -3.87900244604385278e-03 2.65436069484330760e-03 4.70024368248532238e-03 1.77267055201379975e-17 4.70024368248532151e-03 1.77334817837160319e-17 -3.87900244604383240e-03 -2.65436069484333145e-03 -8.03573576977441653e-04 -2.59725647409761147e-03 -8.03573576977412488e-04 2.59725647409761624e-03 -8.03573576977444255e-04 -2.59725647409760974e-03 -8.03573576977411838e-04 2.59725647409762058e-03 3.93143004127718878e-04 -6.45100292628875138e-18 3.93143004127720721e-04 -7.96888596776845759e-18 1.57257201651088332e-03 -2.71050543121376109e-17 -1.22325124210550368e-03 -5.22596806315351031e-04 7.14395755869364868e-04 1.12209167507806677e-03 7.14395755869364326e-04 1.12209167507806742e-03 4.41026397524791407e-05 -1.32947582920883668e-03 4.41026397524669095e-05 1.32947582920883755e-03 7.14395755869374192e-04 -1.12209167507806460e-03 7.14395755869373325e-04 -1.12209167507806374e-03 -1.22325124210551106e-03 5.22596806315338020e-04 4.97908294292655814e-04 -5.86597719031618650e-04 -7.42180545563635771e-04 2.02922623887486831e-04 4.97908294292654079e-04 -5.86597719031616916e-04 -7.42180545563636313e-04 2.02922623887488431e-04 -7.42180545563634578e-04 -2.02922623887484256e-04 4.97908294292662970e-04 5.86597719031611061e-04 -7.42180545563634036e-04 -2.02922623887483281e-04 4.97908294292661018e-04 5.86597719031610411e-04 1.17914860235303408e-03 -8.06879022893488142e-04 -1.42879151173874210e-03 -8.45677694538693459e-18 -1.42879151173873993e-03 -7.39290356363553336e-18 1.17914860235302735e-03 8.06879022893505489e-04 2.44272251270981149e-04 7.89520342919103964e-04 2.44272251270962935e-04 -7.89520342919111553e-04 2.44272251270980932e-04 7.89520342919101253e-04 2.44272251270962176e-04 -7.89520342919112746e-04 2.39017134064896803e-04 3.75420954186464495e-04 2.39017134064909082e-04 -3.75420954186474524e-04 -4.78034268129824995e-04 -1.60461921527854656e-17 -4.63782392664773620e-04 -3.67917140684232108e-04 1.74975659549736885e-04 5.65544559447137560e-04 1.74975659549736181e-04 5.65544559447137777e-04 1.74975659549745396e-04 -5.65544559447132790e-04 1.74975659549742062e-04 5.65544559447139295e-04 1.74975659549742252e-04 -5.65544559447138970e-04 1.74975659549743336e-04 -5.65544559447139295e-04 -4.63782392664778933e-04 3.67917140684222946e-04 2.82593529509100666e-04 -1.93375788693048558e-04 -3.42422689921496339e-04 3.83875331695648914e-18 2.82593529509101262e-04 -1.93375788693051404e-04 -3.42422689921496718e-04 4.55534319033362722e-18 -3.42422689921485280e-04 -8.65117100678179651e-18 2.82593529509108201e-04 1.93375788693043923e-04 -3.42422689921487286e-04 -9.03021825067809591e-18 2.82593529509107713e-04 1.93375788693043814e-04 2.82593529509098606e-04 -1.93375788693050970e-04 -3.42422689921490701e-04 -7.00326840789855520e-18 -3.42422689921491406e-04 -6.94101148627536413e-18 2.82593529509100232e-04 1.93375788693044329e-04 5.85420340659764627e-05 1.89215625477152721e-04 5.85420340659924005e-05 -1.89215625477162479e-04 5.85420340659733186e-05 1.89215625477151745e-04 5.85420340659912621e-05 -1.89215625477163021e-04 5.85420340659595492e-05 1.89215625477162018e-04 5.85420340660127022e-05 -1.89215625477167141e-04 -1.14565196267454395e-04 8.86335276006899875e-18 2 27 27
 DEAL:3d::OK
index d946db6a813c39d0480b8084f5bf4f420194f354..ef24513e2d9d6fb69dd600adebedb185ff9d31e7 100644 (file)
@@ -32,20 +32,22 @@ void
 test()
 {
   // setup
-  hp::FECollection<dim> hp_fe;
-  hp::QCollection<dim>  hp_q;
+  std::vector<unsigned int> n_modes;
+  hp::FECollection<dim>     hp_fe;
+  hp::QCollection<dim>      hp_q;
 
   const unsigned int min_degree = 1, max_degree = 2;
   const QGauss<dim>  quadrature(max_degree + 1);
   const QSorted<dim> quadrature_sorted(quadrature);
   for (unsigned int p = min_degree; p <= max_degree; ++p)
     {
+      n_modes.push_back(max_degree + 1);
       hp_fe.push_back(FE_Q<dim>(p));
       hp_q.push_back(quadrature_sorted);
     }
 
-  FESeries::Legendre<dim> legendre_save(max_degree + 1, hp_fe, hp_q);
-  FESeries::Legendre<dim> legendre_load(max_degree + 1, hp_fe, hp_q);
+  FESeries::Legendre<dim> legendre_save(n_modes, hp_fe, hp_q);
+  FESeries::Legendre<dim> legendre_load(n_modes, hp_fe, hp_q);
 
   // create transformation matrices
   legendre_save.precalculate_all_transformation_matrices();
index 80688c3a6001f0d67f2fa6e640e347d36ec33be4..edc0ab7e3ae0350c95d60fdaac5f8422f7665314 100644 (file)
@@ -1,7 +1,7 @@
 
-DEAL:1d::3 2 10 FE_Q<1>(1) 10 FE_Q<1>(2) 2 0 0 0 0 0 0 3 0 0 0 0 0 1 0 0 1.12701665379258312e-01 1 8.87298334620741702e-01 1 5.00000000000000000e-01 3 0 2.77777777777777790e-01 2.77777777777777790e-01 4.44444444444444420e-01 3 0 1 1.12701665379258312e-01 1 8.87298334620741702e-01 1 5.00000000000000000e-01 3 0 2.77777777777777790e-01 2.77777777777777790e-01 4.44444444444444420e-01 0 0 2 0 0 0 0 0 6 3.53553390593273786e-01 3.53553390593273786e-01 -3.53553390593273786e-01 3.53553390593273786e-01 1.38777878078144568e-16 1.38777878078144568e-16 0 0 2 3 2 9 1.17851130197757933e-01 1.17851130197757933e-01 4.71404520791031678e-01 -3.53553390593273842e-01 3.53553390593273842e-01 -2.08166817117216851e-17 2.35702260395515950e-01 2.35702260395515950e-01 -4.71404520791031567e-01 2 3 3
+DEAL:1d::2 0 3 3 2 10 FE_Q<1>(1) 10 FE_Q<1>(2) 2 0 0 0 0 0 0 3 0 0 0 0 0 1 0 0 1.12701665379258312e-01 1 8.87298334620741702e-01 1 5.00000000000000000e-01 3 0 2.77777777777777790e-01 2.77777777777777790e-01 4.44444444444444420e-01 3 0 1 1.12701665379258312e-01 1 8.87298334620741702e-01 1 5.00000000000000000e-01 3 0 2.77777777777777790e-01 2.77777777777777790e-01 4.44444444444444420e-01 0 0 2 0 0 0 0 0 6 3.53553390593273786e-01 3.53553390593273786e-01 -3.53553390593273786e-01 3.53553390593273786e-01 1.38777878078144568e-16 1.38777878078144568e-16 0 0 2 3 2 9 1.17851130197757933e-01 1.17851130197757933e-01 4.71404520791031678e-01 -3.53553390593273842e-01 3.53553390593273842e-01 -2.08166817117216851e-17 2.35702260395515950e-01 2.35702260395515950e-01 -4.71404520791031567e-01 2 3 3
 DEAL:1d::OK
-DEAL:2d::3 2 10 FE_Q<2>(1) 10 FE_Q<2>(2) 2 0 0 0 0 0 0 9 0 0 0 0 0 2 0 0 1.12701665379258312e-01 1.12701665379258312e-01 2 8.87298334620741702e-01 1.12701665379258312e-01 2 1.12701665379258312e-01 8.87298334620741702e-01 2 8.87298334620741702e-01 8.87298334620741702e-01 2 5.00000000000000000e-01 1.12701665379258312e-01 2 1.12701665379258312e-01 5.00000000000000000e-01 2 8.87298334620741702e-01 5.00000000000000000e-01 2 5.00000000000000000e-01 8.87298334620741702e-01 2 5.00000000000000000e-01 5.00000000000000000e-01 9 0 7.71604938271605034e-02 7.71604938271605034e-02 7.71604938271605034e-02 7.71604938271605034e-02 1.23456790123456783e-01 1.23456790123456783e-01 1.23456790123456783e-01 1.23456790123456783e-01 1.97530864197530853e-01 9 0 2 1.12701665379258312e-01 1.12701665379258312e-01 2 8.87298334620741702e-01 1.12701665379258312e-01 2 1.12701665379258312e-01 8.87298334620741702e-01 2 8.87298334620741702e-01 8.87298334620741702e-01 2 5.00000000000000000e-01 1.12701665379258312e-01 2 1.12701665379258312e-01 5.00000000000000000e-01 2 8.87298334620741702e-01 5.00000000000000000e-01 2 5.00000000000000000e-01 8.87298334620741702e-01 2 5.00000000000000000e-01 5.00000000000000000e-01 9 0 7.71604938271605034e-02 7.71604938271605034e-02 7.71604938271605034e-02 7.71604938271605034e-02 1.23456790123456783e-01 1.23456790123456783e-01 1.23456790123456783e-01 1.23456790123456783e-01 1.97530864197530853e-01 0 0 2 0 0 0 0 0 36 1.25000000000000028e-01 1.25000000000000028e-01 1.25000000000000028e-01 1.25000000000000028e-01 -1.25000000000000028e-01 -1.25000000000000028e-01 1.25000000000000000e-01 1.25000000000000028e-01 0.00000000000000000e+00 0.00000000000000000e+00 8.67361737988403547e-18 8.67361737988403547e-18 -1.25000000000000028e-01 1.25000000000000028e-01 -1.25000000000000028e-01 1.25000000000000028e-01 1.25000000000000083e-01 -1.25000000000000083e-01 -1.25000000000000083e-01 1.25000000000000056e-01 -2.92734586571086197e-17 2.60208521396521064e-17 -2.92734586571086197e-17 2.60208521396521064e-17 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 1.73472347597680709e-17 -2.92734586571086197e-17 -2.92734586571086197e-17 2.60208521396521064e-17 2.60208521396521064e-17 8.67361737988403547e-17 8.67361737988403547e-17 8.67361737988403547e-17 6.50521303491302660e-17 0 0 2 9 4 81 1.38888888888888968e-02 1.38888888888888968e-02 1.38888888888888968e-02 1.38888888888888951e-02 5.55555555555555802e-02 5.55555555555555802e-02 5.55555555555555802e-02 5.55555555555555733e-02 2.22222222222222265e-01 -4.16666666666666921e-02 -4.16666666666666921e-02 4.16666666666666852e-02 4.16666666666666852e-02 0.00000000000000000e+00 0.00000000000000000e+00 -1.66666666666666685e-01 1.66666666666666685e-01 -1.04083408558608426e-17 2.77777777777777901e-02 2.77777777777777901e-02 2.77777777777777901e-02 2.77777777777777901e-02 -5.55555555555555663e-02 -5.55555555555555663e-02 1.11111111111111147e-01 1.11111111111111147e-01 -2.22222222222222265e-01 -4.16666666666666990e-02 4.16666666666666990e-02 -4.16666666666666852e-02 4.16666666666666921e-02 -1.66666666666666685e-01 1.66666666666666685e-01 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 1.25000000000000056e-01 -1.25000000000000056e-01 -1.25000000000000083e-01 1.25000000000000083e-01 2.92734586571086197e-18 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 7.80625564189563192e-18 -8.33333333333333842e-02 8.33333333333333842e-02 -8.33333333333333842e-02 8.33333333333333842e-02 1.66666666666666657e-01 -1.66666666666666657e-01 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 2.77777777777777901e-02 2.77777777777777901e-02 2.77777777777777901e-02 2.77777777777777901e-02 1.11111111111111147e-01 1.11111111111111147e-01 -5.55555555555555663e-02 -5.55555555555555663e-02 -2.22222222222222265e-01 -8.33333333333333842e-02 -8.33333333333333842e-02 8.33333333333333842e-02 8.33333333333333842e-02 8.13151629364128326e-19 0.00000000000000000e+00 1.66666666666666657e-01 -1.66666666666666657e-01 0.00000000000000000e+00 5.55555555555555802e-02 5.55555555555555802e-02 5.55555555555555872e-02 5.55555555555555872e-02 -1.11111111111111133e-01 -1.11111111111111133e-01 -1.11111111111111133e-01 -1.11111111111111133e-01 2.22222222222222349e-01 2 9 9
+DEAL:2d::2 0 3 3 2 10 FE_Q<2>(1) 10 FE_Q<2>(2) 2 0 0 0 0 0 0 9 0 0 0 0 0 2 0 0 1.12701665379258312e-01 1.12701665379258312e-01 2 8.87298334620741702e-01 1.12701665379258312e-01 2 1.12701665379258312e-01 8.87298334620741702e-01 2 8.87298334620741702e-01 8.87298334620741702e-01 2 5.00000000000000000e-01 1.12701665379258312e-01 2 1.12701665379258312e-01 5.00000000000000000e-01 2 8.87298334620741702e-01 5.00000000000000000e-01 2 5.00000000000000000e-01 8.87298334620741702e-01 2 5.00000000000000000e-01 5.00000000000000000e-01 9 0 7.71604938271605034e-02 7.71604938271605034e-02 7.71604938271605034e-02 7.71604938271605034e-02 1.23456790123456783e-01 1.23456790123456783e-01 1.23456790123456783e-01 1.23456790123456783e-01 1.97530864197530853e-01 9 0 2 1.12701665379258312e-01 1.12701665379258312e-01 2 8.87298334620741702e-01 1.12701665379258312e-01 2 1.12701665379258312e-01 8.87298334620741702e-01 2 8.87298334620741702e-01 8.87298334620741702e-01 2 5.00000000000000000e-01 1.12701665379258312e-01 2 1.12701665379258312e-01 5.00000000000000000e-01 2 8.87298334620741702e-01 5.00000000000000000e-01 2 5.00000000000000000e-01 8.87298334620741702e-01 2 5.00000000000000000e-01 5.00000000000000000e-01 9 0 7.71604938271605034e-02 7.71604938271605034e-02 7.71604938271605034e-02 7.71604938271605034e-02 1.23456790123456783e-01 1.23456790123456783e-01 1.23456790123456783e-01 1.23456790123456783e-01 1.97530864197530853e-01 0 0 2 0 0 0 0 0 36 1.25000000000000028e-01 1.25000000000000028e-01 1.25000000000000028e-01 1.25000000000000028e-01 -1.25000000000000028e-01 -1.25000000000000028e-01 1.25000000000000000e-01 1.25000000000000028e-01 0.00000000000000000e+00 0.00000000000000000e+00 8.67361737988403547e-18 8.67361737988403547e-18 -1.25000000000000028e-01 1.25000000000000028e-01 -1.25000000000000028e-01 1.25000000000000028e-01 1.25000000000000083e-01 -1.25000000000000083e-01 -1.25000000000000083e-01 1.25000000000000056e-01 -2.92734586571086197e-17 2.60208521396521064e-17 -2.92734586571086197e-17 2.60208521396521064e-17 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 1.73472347597680709e-17 -2.92734586571086197e-17 -2.92734586571086197e-17 2.60208521396521064e-17 2.60208521396521064e-17 8.67361737988403547e-17 8.67361737988403547e-17 8.67361737988403547e-17 6.50521303491302660e-17 0 0 2 9 4 81 1.38888888888888968e-02 1.38888888888888968e-02 1.38888888888888968e-02 1.38888888888888951e-02 5.55555555555555802e-02 5.55555555555555802e-02 5.55555555555555802e-02 5.55555555555555733e-02 2.22222222222222265e-01 -4.16666666666666921e-02 -4.16666666666666921e-02 4.16666666666666852e-02 4.16666666666666852e-02 0.00000000000000000e+00 0.00000000000000000e+00 -1.66666666666666685e-01 1.66666666666666685e-01 -1.04083408558608426e-17 2.77777777777777901e-02 2.77777777777777901e-02 2.77777777777777901e-02 2.77777777777777901e-02 -5.55555555555555663e-02 -5.55555555555555663e-02 1.11111111111111147e-01 1.11111111111111147e-01 -2.22222222222222265e-01 -4.16666666666666990e-02 4.16666666666666990e-02 -4.16666666666666852e-02 4.16666666666666921e-02 -1.66666666666666685e-01 1.66666666666666685e-01 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 1.25000000000000056e-01 -1.25000000000000056e-01 -1.25000000000000083e-01 1.25000000000000083e-01 2.92734586571086197e-18 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 7.80625564189563192e-18 -8.33333333333333842e-02 8.33333333333333842e-02 -8.33333333333333842e-02 8.33333333333333842e-02 1.66666666666666657e-01 -1.66666666666666657e-01 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 2.77777777777777901e-02 2.77777777777777901e-02 2.77777777777777901e-02 2.77777777777777901e-02 1.11111111111111147e-01 1.11111111111111147e-01 -5.55555555555555663e-02 -5.55555555555555663e-02 -2.22222222222222265e-01 -8.33333333333333842e-02 -8.33333333333333842e-02 8.33333333333333842e-02 8.33333333333333842e-02 8.13151629364128326e-19 0.00000000000000000e+00 1.66666666666666657e-01 -1.66666666666666657e-01 0.00000000000000000e+00 5.55555555555555802e-02 5.55555555555555802e-02 5.55555555555555872e-02 5.55555555555555872e-02 -1.11111111111111133e-01 -1.11111111111111133e-01 -1.11111111111111133e-01 -1.11111111111111133e-01 2.22222222222222349e-01 2 9 9
 DEAL:2d::OK
-DEAL:3d::3 2 10 FE_Q<3>(1) 10 FE_Q<3>(2) 2 0 0 0 0 0 0 27 0 0 0 0 0 3 0 0 1.12701665379258312e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 5.00000000000000000e-01 27 0 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141267e-02 5.48696844993141267e-02 8.77914951989025999e-02 27 0 3 1.12701665379258312e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 5.00000000000000000e-01 27 0 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141267e-02 5.48696844993141267e-02 8.77914951989025999e-02 0 0 2 0 0 0 0 0 216 4.41941738241592233e-02 4.41941738241592233e-02 4.41941738241592233e-02 4.41941738241592302e-02 4.41941738241592233e-02 4.41941738241592233e-02 4.41941738241592233e-02 4.41941738241592233e-02 -4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 1.19262238973405488e-17 1.84314369322535754e-17 1.19262238973405488e-17 1.73472347597680709e-17 1.19262238973405488e-17 1.84314369322535754e-17 2.16840434497100887e-17 2.27682456221955931e-17 -4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592302e-02 4.41941738241592441e-02 -4.41941738241592302e-02 -4.41941738241592441e-02 -4.41941738241592302e-02 -4.41941738241592302e-02 4.41941738241592441e-02 4.41941738241592441e-02 -1.62630325872825665e-17 -1.62630325872825665e-17 1.26038502551439890e-17 1.26038502551439890e-17 -1.62630325872825665e-17 -1.62630325872825665e-17 1.91090632900570156e-17 1.91090632900570156e-17 5.42101086242752217e-18 5.42101086242752217e-18 1.08420217248550443e-18 5.42101086242752217e-18 6.50521303491302660e-18 6.50521303491302660e-18 2.16840434497100887e-18 1.08420217248550443e-17 -9.75781955236953991e-18 -9.75781955236953991e-18 -9.75781955236953991e-18 -9.75781955236953991e-18 0.00000000000000000e+00 0.00000000000000000e+00 3.25260651745651330e-18 3.25260651745651330e-18 2.71050543121376109e-18 -1.62630325872825665e-17 -2.71050543121376109e-18 -5.42101086242752217e-18 -5.42101086242752217e-18 -2.71050543121376109e-18 -2.71050543121376109e-18 -5.42101086242752217e-18 -4.41941738241592441e-02 4.41941738241592302e-02 -4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592302e-02 4.41941738241592302e-02 -4.41941738241592302e-02 4.41941738241592302e-02 -1.62630325872825665e-17 1.26038502551439890e-17 -1.62630325872825665e-17 1.26038502551439890e-17 -1.95156391047390798e-17 1.91090632900570156e-17 -1.62630325872825665e-17 1.58564567726005023e-17 4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592302e-02 4.41941738241592302e-02 4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592302e-02 4.41941738241592302e-02 -4.41941738241592580e-02 4.41941738241592649e-02 4.41941738241592511e-02 -4.41941738241592511e-02 4.41941738241592511e-02 -4.41941738241592511e-02 -4.41941738241592511e-02 4.41941738241592441e-02 9.75781955236953991e-18 -8.53809210832334742e-18 -8.53809210832334742e-18 -1.98205709657506279e-18 1.95156391047390798e-17 -8.53809210832334742e-18 -1.82959116606928873e-17 7.77576245579447711e-18 -1.30104260698260532e-17 1.91090632900570156e-17 -1.95156391047390798e-17 1.91090632900570156e-17 -1.30104260698260532e-17 1.26038502551439890e-17 -1.30104260698260532e-17 1.26038502551439890e-17 1.95156391047390798e-17 -1.82959116606928873e-17 1.95156391047390798e-17 -8.53809210832334742e-18 -1.82959116606928873e-17 1.76860479386697911e-17 -1.82959116606928873e-17 1.76860479386697911e-17 2.43945488809238498e-17 1.01643953670516041e-18 2.43945488809238498e-17 1.01643953670516041e-18 1.62630325872825665e-17 -7.11507675693612285e-18 2.43945488809238498e-17 -7.11507675693612285e-18 1.08420217248550443e-18 1.08420217248550443e-18 5.42101086242752217e-18 5.42101086242752217e-18 2.16840434497100887e-18 1.08420217248550443e-17 6.50521303491302660e-18 6.50521303491302660e-18 -3.25260651745651330e-18 -6.50521303491302660e-18 -3.25260651745651330e-18 -6.50521303491302660e-18 -6.50521303491302660e-18 3.25260651745651330e-18 0.00000000000000000e+00 3.25260651745651330e-18 -2.71050543121376109e-18 -8.13151629364128326e-18 -5.42101086242752217e-18 -8.13151629364128326e-18 -2.71050543121376109e-18 8.13151629364128326e-18 -2.71050543121376109e-18 -2.71050543121376109e-18 -1.62630325872825665e-17 -1.62630325872825665e-17 1.91090632900570156e-17 1.91090632900570156e-17 -1.30104260698260532e-17 -1.62630325872825665e-17 9.35124373768747574e-18 1.26038502551439890e-17 3.17129135452010047e-17 1.21972744404619249e-17 -1.95156391047390798e-17 -2.92734586571086197e-17 -2.01255028267621761e-17 -2.98833223791317160e-17 7.31836466427715493e-18 1.70761842166466948e-17 8.13151629364128326e-18 2.43945488809238498e-17 -1.52465930505774061e-17 -7.11507675693612285e-18 8.13151629364128326e-18 1.62630325872825665e-17 -7.11507675693612285e-18 -7.11507675693612285e-18 1.89735380184963276e-17 8.13151629364128326e-18 1.89735380184963276e-17 1.89735380184963276e-17 1.62630325872825665e-17 1.62630325872825665e-17 1.62630325872825665e-17 5.42101086242752217e-18 -8.13151629364128326e-18 -1.62630325872825665e-17 -1.62630325872825665e-17 -1.62630325872825665e-17 1.62630325872825665e-17 2.43945488809238498e-17 1.62630325872825665e-17 8.13151629364128326e-18 3.38813178901720136e-17 1.35525271560688054e-17 0.00000000000000000e+00 2.03287907341032081e-17 2.03287907341032081e-17 -1.35525271560688054e-17 2.03287907341032081e-17 -6.77626357803440271e-18 0 0 2 27 8 729 1.63682125274663927e-03 1.63682125274663948e-03 1.63682125274663905e-03 1.63682125274663905e-03 1.63682125274663905e-03 1.63682125274663905e-03 1.63682125274663927e-03 1.63682125274663905e-03 6.54728501098655446e-03 6.54728501098655359e-03 6.54728501098655359e-03 6.54728501098655359e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655359e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 2.61891400439462144e-02 2.61891400439462178e-02 2.61891400439462144e-02 2.61891400439462144e-02 2.61891400439462178e-02 2.61891400439462144e-02 1.04756560175784830e-01 -4.91046375823991736e-03 -4.91046375823991736e-03 -4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 -1.96418550329596625e-02 -1.96418550329596625e-02 -1.96418550329596625e-02 -1.96418550329596625e-02 1.96418550329596625e-02 1.96418550329596625e-02 1.96418550329596625e-02 1.96418550329596625e-02 -6.50521303491302660e-19 -5.69206140554889828e-19 -5.69206140554889828e-19 -5.69206140554889828e-19 0.00000000000000000e+00 -3.25260651745651330e-19 -3.25260651745651330e-19 0.00000000000000000e+00 -7.85674201318386639e-02 7.85674201318386500e-02 -5.20417042793042128e-18 3.27364250549327853e-03 3.27364250549327896e-03 3.27364250549327853e-03 3.27364250549327853e-03 3.27364250549327853e-03 3.27364250549327853e-03 3.27364250549327853e-03 3.27364250549327896e-03 1.30945700219731089e-02 1.30945700219731107e-02 1.30945700219731089e-02 1.30945700219731107e-02 1.30945700219731107e-02 1.30945700219731107e-02 1.30945700219731107e-02 1.30945700219731089e-02 -6.54728501098655186e-03 -6.54728501098655186e-03 -6.54728501098655186e-03 -6.54728501098655186e-03 -2.61891400439462074e-02 -2.61891400439462040e-02 -2.61891400439462074e-02 -2.61891400439462040e-02 5.23782800878924287e-02 5.23782800878924426e-02 -1.04756560175784802e-01 -4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 -4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 0.00000000000000000e+00 -8.13151629364128326e-20 -1.96418550329596625e-02 1.96418550329596625e-02 0.00000000000000000e+00 -8.13151629364128326e-20 -1.96418550329596625e-02 1.96418550329596625e-02 -1.96418550329596625e-02 -1.96418550329596625e-02 1.96418550329596625e-02 1.96418550329596625e-02 0.00000000000000000e+00 -3.25260651745651330e-19 -7.85674201318386500e-02 7.85674201318386500e-02 -1.30104260698260532e-18 -9.75781955236953991e-19 -7.80625564189563192e-18 1.47313912747197504e-02 1.47313912747197504e-02 -1.47313912747197504e-02 -1.47313912747197504e-02 -1.47313912747197504e-02 -1.47313912747197504e-02 1.47313912747197504e-02 1.47313912747197504e-02 -6.09863722023096244e-19 -3.81164826264435153e-19 5.89255650988789875e-02 -5.89255650988789806e-02 0.00000000000000000e+00 -2.43945488809238498e-19 -5.89255650988789875e-02 5.89255650988789806e-02 9.75781955236953991e-19 7.31836466427715493e-19 -1.58564567726005023e-18 -1.35694678150138914e-18 0.00000000000000000e+00 2.43945488809238498e-19 4.87890977618476995e-19 0.00000000000000000e+00 3.90312782094781596e-18 -3.41523684332933897e-18 0.00000000000000000e+00 -9.82092751647983472e-03 -9.82092751647983646e-03 9.82092751647983646e-03 9.82092751647983646e-03 -9.82092751647983646e-03 -9.82092751647983472e-03 9.82092751647983819e-03 9.82092751647983646e-03 2.03287907341032081e-19 -6.47980204649539759e-19 -3.92837100659193389e-02 3.92837100659193320e-02 0.00000000000000000e+00 8.13151629364128326e-19 -3.92837100659193320e-02 3.92837100659193320e-02 1.96418550329596556e-02 1.96418550329596556e-02 -1.96418550329596556e-02 -1.96418550329596556e-02 0.00000000000000000e+00 8.13151629364128326e-19 7.85674201318386362e-02 -7.85674201318386362e-02 0.00000000000000000e+00 1.21972744404619249e-18 6.50521303491302660e-18 3.27364250549327896e-03 3.27364250549327896e-03 3.27364250549327766e-03 3.27364250549327766e-03 3.27364250549327723e-03 3.27364250549327766e-03 3.27364250549327853e-03 3.27364250549327896e-03 -6.54728501098655359e-03 -6.54728501098655186e-03 1.30945700219731072e-02 1.30945700219731089e-02 -6.54728501098655186e-03 -6.54728501098655186e-03 1.30945700219731089e-02 1.30945700219731072e-02 1.30945700219731089e-02 1.30945700219731089e-02 1.30945700219731089e-02 1.30945700219731089e-02 -2.61891400439462144e-02 -2.61891400439462074e-02 5.23782800878924149e-02 5.23782800878924287e-02 -2.61891400439462178e-02 -2.61891400439462144e-02 -1.04756560175784830e-01 -9.82092751647983472e-03 -9.82092751647983299e-03 -9.82092751647983299e-03 -9.82092751647983299e-03 9.82092751647983299e-03 9.82092751647983125e-03 9.82092751647983125e-03 9.82092751647982952e-03 1.96418550329596590e-02 1.96418550329596590e-02 -3.92837100659193320e-02 -3.92837100659193250e-02 -1.96418550329596590e-02 -1.96418550329596590e-02 3.92837100659193250e-02 3.92837100659193250e-02 -8.13151629364128326e-19 -7.11507675693612285e-19 -9.14795583034644366e-19 -8.89384594617015356e-19 -3.25260651745651330e-18 -2.43945488809238498e-18 1.62630325872825665e-18 0.00000000000000000e+00 7.85674201318386500e-02 -7.85674201318386500e-02 6.50521303491302660e-18 6.54728501098655272e-03 6.54728501098655272e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655619e-03 6.54728501098655446e-03 6.54728501098655446e-03 -1.30945700219731054e-02 -1.30945700219731037e-02 2.61891400439462248e-02 2.61891400439462248e-02 -1.30945700219731037e-02 -1.30945700219731089e-02 2.61891400439462248e-02 2.61891400439462178e-02 -1.30945700219730985e-02 -1.30945700219731037e-02 -1.30945700219730985e-02 -1.30945700219731002e-02 2.61891400439462074e-02 2.61891400439462178e-02 -5.23782800878924149e-02 -5.23782800878924149e-02 -5.23782800878924357e-02 -5.23782800878924149e-02 1.04756560175784830e-01 -4.91046375823991736e-03 4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991563e-03 -1.96418550329596625e-02 1.96418550329596625e-02 0.00000000000000000e+00 0.00000000000000000e+00 -1.96418550329596625e-02 1.96418550329596625e-02 0.00000000000000000e+00 0.00000000000000000e+00 -1.96418550329596625e-02 1.96418550329596625e-02 -1.96418550329596625e-02 1.96418550329596660e-02 -7.85674201318386500e-02 7.85674201318386500e-02 0.00000000000000000e+00 0.00000000000000000e+00 -1.30104260698260532e-18 -1.30104260698260532e-18 -7.80625564189563192e-18 1.47313912747197504e-02 -1.47313912747197504e-02 1.47313912747197504e-02 -1.47313912747197504e-02 -1.47313912747197504e-02 1.47313912747197504e-02 -1.47313912747197504e-02 1.47313912747197504e-02 5.89255650988789806e-02 -5.89255650988789806e-02 0.00000000000000000e+00 0.00000000000000000e+00 -5.89255650988789875e-02 5.89255650988789875e-02 0.00000000000000000e+00 0.00000000000000000e+00 9.75781955236953991e-19 -1.21972744404619249e-18 6.09863722023096244e-19 1.06726151354041843e-19 0.00000000000000000e+00 -4.87890977618476995e-19 0.00000000000000000e+00 0.00000000000000000e+00 3.90312782094781596e-18 -3.90312782094781596e-18 1.95156391047390798e-18 -9.82092751647983819e-03 9.82092751647983646e-03 -9.82092751647983646e-03 9.82092751647983646e-03 -9.82092751647983646e-03 9.82092751647983472e-03 -9.82092751647983819e-03 9.82092751647983646e-03 -3.92837100659193320e-02 3.92837100659193320e-02 0.00000000000000000e+00 0.00000000000000000e+00 -3.92837100659193320e-02 3.92837100659193320e-02 0.00000000000000000e+00 0.00000000000000000e+00 1.96418550329596556e-02 -1.96418550329596556e-02 1.96418550329596556e-02 -1.96418550329596556e-02 7.85674201318386223e-02 -7.85674201318386362e-02 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 6.50521303491302660e-18 1.47313912747197538e-02 -1.47313912747197538e-02 -1.47313912747197538e-02 1.47313912747197538e-02 1.47313912747197538e-02 -1.47313912747197538e-02 -1.47313912747197538e-02 1.47313912747197538e-02 -6.09863722023096244e-19 -2.05829006182794982e-18 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 -1.70761842166466948e-18 0.00000000000000000e+00 0.00000000000000000e+00 5.89255650988790014e-02 -5.89255650988790014e-02 -5.89255650988790014e-02 5.89255650988789875e-02 0.00000000000000000e+00 -9.75781955236953991e-19 0.00000000000000000e+00 0.00000000000000000e+00 -2.43945488809238498e-19 0.00000000000000000e+00 0.00000000000000000e+00 -4.41941738241592649e-02 4.41941738241592649e-02 4.41941738241592580e-02 -4.41941738241592649e-02 4.41941738241592580e-02 -4.41941738241592580e-02 -4.41941738241592649e-02 4.41941738241592649e-02 1.09775469964157324e-18 -1.14349447879330546e-18 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 -2.92734586571086197e-18 2.92734586571086197e-18 4.39101879856629296e-18 -4.07084034450416743e-18 0.00000000000000000e+00 1.28071381624850211e-18 0.00000000000000000e+00 0.00000000000000000e+00 -1.64663204946235986e-18 1.46367293285543099e-18 -7.31836466427715493e-19 2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395042e-02 2.94627825494395042e-02 2.94627825494395111e-02 -2.94627825494395042e-02 -2.94627825494395111e-02 2.94627825494395042e-02 6.09863722023096244e-19 5.71747239396652729e-19 0.00000000000000000e+00 0.00000000000000000e+00 2.43945488809238498e-18 -1.21972744404619249e-18 0.00000000000000000e+00 0.00000000000000000e+00 -5.89255650988789736e-02 5.89255650988789806e-02 5.89255650988789806e-02 -5.89255650988789806e-02 0.00000000000000000e+00 2.43945488809238498e-18 0.00000000000000000e+00 0.00000000000000000e+00 7.62329652528870305e-19 1.21972744404619249e-18 0.00000000000000000e+00 -9.82092751647983819e-03 9.82092751647983646e-03 -9.82092751647983646e-03 9.82092751647983646e-03 -9.82092751647983646e-03 9.82092751647983472e-03 -9.82092751647983819e-03 9.82092751647983646e-03 1.96418550329596556e-02 -1.96418550329596556e-02 0.00000000000000000e+00 0.00000000000000000e+00 1.96418550329596556e-02 -1.96418550329596556e-02 0.00000000000000000e+00 0.00000000000000000e+00 -3.92837100659193320e-02 3.92837100659193320e-02 -3.92837100659193389e-02 3.92837100659193389e-02 7.85674201318386223e-02 -7.85674201318386362e-02 0.00000000000000000e+00 0.00000000000000000e+00 -3.25260651745651330e-18 -3.25260651745651330e-18 6.50521303491302660e-18 2.94627825494395042e-02 -2.94627825494395042e-02 2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395111e-02 2.94627825494395042e-02 -2.94627825494395111e-02 2.94627825494395042e-02 -5.89255650988789736e-02 5.89255650988789736e-02 0.00000000000000000e+00 0.00000000000000000e+00 5.89255650988789736e-02 -5.89255650988789598e-02 0.00000000000000000e+00 0.00000000000000000e+00 2.43945488809238498e-18 -3.65918233213857746e-18 4.57397791517322183e-18 -5.45065701558142268e-18 0.00000000000000000e+00 1.21972744404619249e-18 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 -1.96418550329596660e-02 1.96418550329596660e-02 -1.96418550329596729e-02 1.96418550329596729e-02 -1.96418550329596729e-02 1.96418550329596729e-02 -1.96418550329596660e-02 1.96418550329596660e-02 3.92837100659193250e-02 -3.92837100659193250e-02 0.00000000000000000e+00 0.00000000000000000e+00 3.92837100659193181e-02 -3.92837100659193181e-02 0.00000000000000000e+00 0.00000000000000000e+00 3.92837100659193181e-02 -3.92837100659193181e-02 3.92837100659193181e-02 -3.92837100659193181e-02 -7.85674201318386362e-02 7.85674201318386223e-02 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 3.27364250549327896e-03 3.27364250549327896e-03 3.27364250549327766e-03 3.27364250549327766e-03 3.27364250549327723e-03 3.27364250549327766e-03 3.27364250549327853e-03 3.27364250549327896e-03 1.30945700219731089e-02 1.30945700219731089e-02 -6.54728501098655186e-03 -6.54728501098655186e-03 1.30945700219731089e-02 1.30945700219731089e-02 -6.54728501098655186e-03 -6.54728501098655446e-03 1.30945700219731089e-02 1.30945700219731089e-02 1.30945700219731089e-02 1.30945700219731089e-02 5.23782800878924287e-02 5.23782800878924287e-02 -2.61891400439462074e-02 -2.61891400439462074e-02 -2.61891400439462074e-02 -2.61891400439462144e-02 -1.04756560175784830e-01 -9.82092751647983472e-03 -9.82092751647983299e-03 -9.82092751647983299e-03 -9.82092751647983299e-03 9.82092751647983299e-03 9.82092751647983125e-03 9.82092751647983125e-03 9.82092751647982952e-03 -3.92837100659193250e-02 -3.92837100659193250e-02 1.96418550329596556e-02 1.96418550329596590e-02 3.92837100659193250e-02 3.92837100659193250e-02 -1.96418550329596590e-02 -1.96418550329596590e-02 -8.13151629364128326e-19 -7.11507675693612285e-19 -9.14795583034644366e-19 -8.89384594617015356e-19 0.00000000000000000e+00 -3.25260651745651330e-18 -2.43945488809238498e-18 -3.25260651745651330e-18 7.85674201318386500e-02 -7.85674201318386500e-02 1.30104260698260532e-17 6.54728501098655272e-03 6.54728501098655272e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655619e-03 6.54728501098655446e-03 6.54728501098655446e-03 2.61891400439462248e-02 2.61891400439462248e-02 -1.30945700219731089e-02 -1.30945700219731037e-02 2.61891400439462248e-02 2.61891400439462248e-02 -1.30945700219731037e-02 -1.30945700219731089e-02 -1.30945700219730985e-02 -1.30945700219731037e-02 -1.30945700219730985e-02 -1.30945700219731002e-02 -5.23782800878924149e-02 -5.23782800878924149e-02 2.61891400439462178e-02 2.61891400439462178e-02 -5.23782800878924218e-02 -5.23782800878924149e-02 1.04756560175784830e-01 -9.82092751647983472e-03 -9.82092751647983646e-03 9.82092751647983646e-03 9.82092751647983646e-03 -9.82092751647983646e-03 -9.82092751647983472e-03 9.82092751647983819e-03 9.82092751647983646e-03 2.03287907341032081e-19 -6.47980204649539759e-19 1.96418550329596556e-02 -1.96418550329596556e-02 0.00000000000000000e+00 8.13151629364128326e-19 1.96418550329596590e-02 -1.96418550329596556e-02 -3.92837100659193320e-02 -3.92837100659193320e-02 3.92837100659193389e-02 3.92837100659193389e-02 0.00000000000000000e+00 4.06575814682064163e-19 7.85674201318386223e-02 -7.85674201318386362e-02 0.00000000000000000e+00 2.43945488809238498e-18 6.50521303491302660e-18 2.94627825494395042e-02 2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395111e-02 2.94627825494395042e-02 2.94627825494395042e-02 6.09863722023096244e-19 1.86770764869573225e-18 -5.89255650988789736e-02 5.89255650988789736e-02 2.43945488809238498e-18 1.21972744404619249e-18 5.89255650988789736e-02 -5.89255650988789736e-02 7.31836466427715493e-18 6.09863722023096244e-18 -3.96411419315012559e-18 -3.01120212748903771e-18 -1.21972744404619249e-18 1.52465930505774061e-18 -1.21972744404619249e-18 0.00000000000000000e+00 0.00000000000000000e+00 -6.09863722023096244e-18 0.00000000000000000e+00 -1.96418550329596660e-02 -1.96418550329596660e-02 1.96418550329596660e-02 1.96418550329596660e-02 -1.96418550329596729e-02 -1.96418550329596729e-02 1.96418550329596729e-02 1.96418550329596729e-02 0.00000000000000000e+00 4.12928561786471415e-19 3.92837100659193250e-02 -3.92837100659193250e-02 0.00000000000000000e+00 5.08219768352580203e-19 3.92837100659193181e-02 -3.92837100659193250e-02 3.92837100659193181e-02 3.92837100659193181e-02 -3.92837100659193181e-02 -3.92837100659193181e-02 0.00000000000000000e+00 -1.01643953670516041e-18 -7.85674201318386084e-02 7.85674201318386362e-02 0.00000000000000000e+00 -3.04931861011548122e-18 0.00000000000000000e+00 6.54728501098655272e-03 6.54728501098655272e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655619e-03 6.54728501098655446e-03 6.54728501098655446e-03 -1.30945700219731002e-02 -1.30945700219731037e-02 -1.30945700219731002e-02 -1.30945700219731002e-02 -1.30945700219731002e-02 -1.30945700219731002e-02 -1.30945700219731002e-02 -1.30945700219731037e-02 2.61891400439462248e-02 2.61891400439462248e-02 2.61891400439462248e-02 2.61891400439462248e-02 -5.23782800878924149e-02 -5.23782800878924149e-02 -5.23782800878924010e-02 -5.23782800878924149e-02 2.61891400439462282e-02 2.61891400439462178e-02 1.04756560175784830e-01 -1.96418550329596660e-02 -1.96418550329596660e-02 -1.96418550329596660e-02 -1.96418550329596660e-02 1.96418550329596729e-02 1.96418550329596729e-02 1.96418550329596729e-02 1.96418550329596729e-02 3.92837100659193181e-02 3.92837100659193111e-02 3.92837100659193181e-02 3.92837100659193181e-02 -3.92837100659193181e-02 -3.92837100659193181e-02 -3.92837100659193181e-02 -3.92837100659193111e-02 -4.06575814682064163e-18 -4.57397791517322183e-18 -3.81164826264435153e-18 -4.47868670860711304e-18 0.00000000000000000e+00 0.00000000000000000e+00 -4.06575814682064163e-18 0.00000000000000000e+00 -7.85674201318386500e-02 7.85674201318386917e-02 0.00000000000000000e+00 1.30945700219731176e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731141e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462178e-02 -2.61891400439462109e-02 -2.61891400439462074e-02 -2.61891400439462074e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462074e-02 5.23782800878923802e-02 5.23782800878923940e-02 5.23782800878923940e-02 5.23782800878923940e-02 5.23782800878924218e-02 5.23782800878924495e-02 -1.04756560175784899e-01 2 27 27
+DEAL:3d::2 0 3 3 2 10 FE_Q<3>(1) 10 FE_Q<3>(2) 2 0 0 0 0 0 0 27 0 0 0 0 0 3 0 0 1.12701665379258312e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 5.00000000000000000e-01 27 0 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141267e-02 5.48696844993141267e-02 8.77914951989025999e-02 27 0 3 1.12701665379258312e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 1.12701665379258312e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 8.87298334620741702e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 8.87298334620741702e-01 3 8.87298334620741702e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 8.87298334620741702e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 8.87298334620741702e-01 5.00000000000000000e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 8.87298334620741702e-01 5.00000000000000000e-01 3 1.12701665379258312e-01 5.00000000000000000e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 1.12701665379258312e-01 5.00000000000000000e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 8.87298334620741702e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 1.12701665379258312e-01 3 5.00000000000000000e-01 5.00000000000000000e-01 5.00000000000000000e-01 27 0 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 2.14334705075445858e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 3.42935528120713318e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141197e-02 5.48696844993141267e-02 5.48696844993141267e-02 8.77914951989025999e-02 0 0 2 0 0 0 0 0 216 4.41941738241592233e-02 4.41941738241592233e-02 4.41941738241592233e-02 4.41941738241592302e-02 4.41941738241592233e-02 4.41941738241592233e-02 4.41941738241592233e-02 4.41941738241592233e-02 -4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 1.19262238973405488e-17 1.84314369322535754e-17 1.19262238973405488e-17 1.73472347597680709e-17 1.19262238973405488e-17 1.84314369322535754e-17 2.16840434497100887e-17 2.27682456221955931e-17 -4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592302e-02 4.41941738241592441e-02 -4.41941738241592302e-02 -4.41941738241592441e-02 -4.41941738241592302e-02 -4.41941738241592302e-02 4.41941738241592441e-02 4.41941738241592441e-02 -1.62630325872825665e-17 -1.62630325872825665e-17 1.26038502551439890e-17 1.26038502551439890e-17 -1.62630325872825665e-17 -1.62630325872825665e-17 1.91090632900570156e-17 1.91090632900570156e-17 5.42101086242752217e-18 5.42101086242752217e-18 1.08420217248550443e-18 5.42101086242752217e-18 6.50521303491302660e-18 6.50521303491302660e-18 2.16840434497100887e-18 1.08420217248550443e-17 -9.75781955236953991e-18 -9.75781955236953991e-18 -9.75781955236953991e-18 -9.75781955236953991e-18 0.00000000000000000e+00 0.00000000000000000e+00 3.25260651745651330e-18 3.25260651745651330e-18 2.71050543121376109e-18 -1.62630325872825665e-17 -2.71050543121376109e-18 -5.42101086242752217e-18 -5.42101086242752217e-18 -2.71050543121376109e-18 -2.71050543121376109e-18 -5.42101086242752217e-18 -4.41941738241592441e-02 4.41941738241592302e-02 -4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592302e-02 4.41941738241592302e-02 -4.41941738241592302e-02 4.41941738241592302e-02 -1.62630325872825665e-17 1.26038502551439890e-17 -1.62630325872825665e-17 1.26038502551439890e-17 -1.95156391047390798e-17 1.91090632900570156e-17 -1.62630325872825665e-17 1.58564567726005023e-17 4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592302e-02 4.41941738241592302e-02 4.41941738241592441e-02 -4.41941738241592441e-02 -4.41941738241592302e-02 4.41941738241592302e-02 -4.41941738241592580e-02 4.41941738241592649e-02 4.41941738241592511e-02 -4.41941738241592511e-02 4.41941738241592511e-02 -4.41941738241592511e-02 -4.41941738241592511e-02 4.41941738241592441e-02 9.75781955236953991e-18 -8.53809210832334742e-18 -8.53809210832334742e-18 -1.98205709657506279e-18 1.95156391047390798e-17 -8.53809210832334742e-18 -1.82959116606928873e-17 7.77576245579447711e-18 -1.30104260698260532e-17 1.91090632900570156e-17 -1.95156391047390798e-17 1.91090632900570156e-17 -1.30104260698260532e-17 1.26038502551439890e-17 -1.30104260698260532e-17 1.26038502551439890e-17 1.95156391047390798e-17 -1.82959116606928873e-17 1.95156391047390798e-17 -8.53809210832334742e-18 -1.82959116606928873e-17 1.76860479386697911e-17 -1.82959116606928873e-17 1.76860479386697911e-17 2.43945488809238498e-17 1.01643953670516041e-18 2.43945488809238498e-17 1.01643953670516041e-18 1.62630325872825665e-17 -7.11507675693612285e-18 2.43945488809238498e-17 -7.11507675693612285e-18 1.08420217248550443e-18 1.08420217248550443e-18 5.42101086242752217e-18 5.42101086242752217e-18 2.16840434497100887e-18 1.08420217248550443e-17 6.50521303491302660e-18 6.50521303491302660e-18 -3.25260651745651330e-18 -6.50521303491302660e-18 -3.25260651745651330e-18 -6.50521303491302660e-18 -6.50521303491302660e-18 3.25260651745651330e-18 0.00000000000000000e+00 3.25260651745651330e-18 -2.71050543121376109e-18 -8.13151629364128326e-18 -5.42101086242752217e-18 -8.13151629364128326e-18 -2.71050543121376109e-18 8.13151629364128326e-18 -2.71050543121376109e-18 -2.71050543121376109e-18 -1.62630325872825665e-17 -1.62630325872825665e-17 1.91090632900570156e-17 1.91090632900570156e-17 -1.30104260698260532e-17 -1.62630325872825665e-17 9.35124373768747574e-18 1.26038502551439890e-17 3.17129135452010047e-17 1.21972744404619249e-17 -1.95156391047390798e-17 -2.92734586571086197e-17 -2.01255028267621761e-17 -2.98833223791317160e-17 7.31836466427715493e-18 1.70761842166466948e-17 8.13151629364128326e-18 2.43945488809238498e-17 -1.52465930505774061e-17 -7.11507675693612285e-18 8.13151629364128326e-18 1.62630325872825665e-17 -7.11507675693612285e-18 -7.11507675693612285e-18 1.89735380184963276e-17 8.13151629364128326e-18 1.89735380184963276e-17 1.89735380184963276e-17 1.62630325872825665e-17 1.62630325872825665e-17 1.62630325872825665e-17 5.42101086242752217e-18 -8.13151629364128326e-18 -1.62630325872825665e-17 -1.62630325872825665e-17 -1.62630325872825665e-17 1.62630325872825665e-17 2.43945488809238498e-17 1.62630325872825665e-17 8.13151629364128326e-18 3.38813178901720136e-17 1.35525271560688054e-17 0.00000000000000000e+00 2.03287907341032081e-17 2.03287907341032081e-17 -1.35525271560688054e-17 2.03287907341032081e-17 -6.77626357803440271e-18 0 0 2 27 8 729 1.63682125274663927e-03 1.63682125274663948e-03 1.63682125274663905e-03 1.63682125274663905e-03 1.63682125274663905e-03 1.63682125274663905e-03 1.63682125274663927e-03 1.63682125274663905e-03 6.54728501098655446e-03 6.54728501098655359e-03 6.54728501098655359e-03 6.54728501098655359e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655359e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 2.61891400439462144e-02 2.61891400439462178e-02 2.61891400439462144e-02 2.61891400439462144e-02 2.61891400439462178e-02 2.61891400439462144e-02 1.04756560175784830e-01 -4.91046375823991736e-03 -4.91046375823991736e-03 -4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 -1.96418550329596625e-02 -1.96418550329596625e-02 -1.96418550329596625e-02 -1.96418550329596625e-02 1.96418550329596625e-02 1.96418550329596625e-02 1.96418550329596625e-02 1.96418550329596625e-02 -6.50521303491302660e-19 -5.69206140554889828e-19 -5.69206140554889828e-19 -5.69206140554889828e-19 0.00000000000000000e+00 -3.25260651745651330e-19 -3.25260651745651330e-19 0.00000000000000000e+00 -7.85674201318386639e-02 7.85674201318386500e-02 -5.20417042793042128e-18 3.27364250549327853e-03 3.27364250549327896e-03 3.27364250549327853e-03 3.27364250549327853e-03 3.27364250549327853e-03 3.27364250549327853e-03 3.27364250549327853e-03 3.27364250549327896e-03 1.30945700219731089e-02 1.30945700219731107e-02 1.30945700219731089e-02 1.30945700219731107e-02 1.30945700219731107e-02 1.30945700219731107e-02 1.30945700219731107e-02 1.30945700219731089e-02 -6.54728501098655186e-03 -6.54728501098655186e-03 -6.54728501098655186e-03 -6.54728501098655186e-03 -2.61891400439462074e-02 -2.61891400439462040e-02 -2.61891400439462074e-02 -2.61891400439462040e-02 5.23782800878924287e-02 5.23782800878924426e-02 -1.04756560175784802e-01 -4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 -4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 4.91046375823991736e-03 0.00000000000000000e+00 -8.13151629364128326e-20 -1.96418550329596625e-02 1.96418550329596625e-02 0.00000000000000000e+00 -8.13151629364128326e-20 -1.96418550329596625e-02 1.96418550329596625e-02 -1.96418550329596625e-02 -1.96418550329596625e-02 1.96418550329596625e-02 1.96418550329596625e-02 0.00000000000000000e+00 -3.25260651745651330e-19 -7.85674201318386500e-02 7.85674201318386500e-02 -1.30104260698260532e-18 -9.75781955236953991e-19 -7.80625564189563192e-18 1.47313912747197504e-02 1.47313912747197504e-02 -1.47313912747197504e-02 -1.47313912747197504e-02 -1.47313912747197504e-02 -1.47313912747197504e-02 1.47313912747197504e-02 1.47313912747197504e-02 -6.09863722023096244e-19 -3.81164826264435153e-19 5.89255650988789875e-02 -5.89255650988789806e-02 0.00000000000000000e+00 -2.43945488809238498e-19 -5.89255650988789875e-02 5.89255650988789806e-02 9.75781955236953991e-19 7.31836466427715493e-19 -1.58564567726005023e-18 -1.35694678150138914e-18 0.00000000000000000e+00 2.43945488809238498e-19 4.87890977618476995e-19 0.00000000000000000e+00 3.90312782094781596e-18 -3.41523684332933897e-18 0.00000000000000000e+00 -9.82092751647983472e-03 -9.82092751647983646e-03 9.82092751647983646e-03 9.82092751647983646e-03 -9.82092751647983646e-03 -9.82092751647983472e-03 9.82092751647983819e-03 9.82092751647983646e-03 2.03287907341032081e-19 -6.47980204649539759e-19 -3.92837100659193389e-02 3.92837100659193320e-02 0.00000000000000000e+00 8.13151629364128326e-19 -3.92837100659193320e-02 3.92837100659193320e-02 1.96418550329596556e-02 1.96418550329596556e-02 -1.96418550329596556e-02 -1.96418550329596556e-02 0.00000000000000000e+00 8.13151629364128326e-19 7.85674201318386362e-02 -7.85674201318386362e-02 0.00000000000000000e+00 1.21972744404619249e-18 6.50521303491302660e-18 3.27364250549327896e-03 3.27364250549327896e-03 3.27364250549327766e-03 3.27364250549327766e-03 3.27364250549327723e-03 3.27364250549327766e-03 3.27364250549327853e-03 3.27364250549327896e-03 -6.54728501098655359e-03 -6.54728501098655186e-03 1.30945700219731072e-02 1.30945700219731089e-02 -6.54728501098655186e-03 -6.54728501098655186e-03 1.30945700219731089e-02 1.30945700219731072e-02 1.30945700219731089e-02 1.30945700219731089e-02 1.30945700219731089e-02 1.30945700219731089e-02 -2.61891400439462144e-02 -2.61891400439462074e-02 5.23782800878924149e-02 5.23782800878924287e-02 -2.61891400439462178e-02 -2.61891400439462144e-02 -1.04756560175784830e-01 -9.82092751647983472e-03 -9.82092751647983299e-03 -9.82092751647983299e-03 -9.82092751647983299e-03 9.82092751647983299e-03 9.82092751647983125e-03 9.82092751647983125e-03 9.82092751647982952e-03 1.96418550329596590e-02 1.96418550329596590e-02 -3.92837100659193320e-02 -3.92837100659193250e-02 -1.96418550329596590e-02 -1.96418550329596590e-02 3.92837100659193250e-02 3.92837100659193250e-02 -8.13151629364128326e-19 -7.11507675693612285e-19 -9.14795583034644366e-19 -8.89384594617015356e-19 -3.25260651745651330e-18 -2.43945488809238498e-18 1.62630325872825665e-18 0.00000000000000000e+00 7.85674201318386500e-02 -7.85674201318386500e-02 6.50521303491302660e-18 6.54728501098655272e-03 6.54728501098655272e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655619e-03 6.54728501098655446e-03 6.54728501098655446e-03 -1.30945700219731054e-02 -1.30945700219731037e-02 2.61891400439462248e-02 2.61891400439462248e-02 -1.30945700219731037e-02 -1.30945700219731089e-02 2.61891400439462248e-02 2.61891400439462178e-02 -1.30945700219730985e-02 -1.30945700219731037e-02 -1.30945700219730985e-02 -1.30945700219731002e-02 2.61891400439462074e-02 2.61891400439462178e-02 -5.23782800878924149e-02 -5.23782800878924149e-02 -5.23782800878924357e-02 -5.23782800878924149e-02 1.04756560175784830e-01 -4.91046375823991736e-03 4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991736e-03 -4.91046375823991736e-03 4.91046375823991563e-03 -1.96418550329596625e-02 1.96418550329596625e-02 0.00000000000000000e+00 0.00000000000000000e+00 -1.96418550329596625e-02 1.96418550329596625e-02 0.00000000000000000e+00 0.00000000000000000e+00 -1.96418550329596625e-02 1.96418550329596625e-02 -1.96418550329596625e-02 1.96418550329596660e-02 -7.85674201318386500e-02 7.85674201318386500e-02 0.00000000000000000e+00 0.00000000000000000e+00 -1.30104260698260532e-18 -1.30104260698260532e-18 -7.80625564189563192e-18 1.47313912747197504e-02 -1.47313912747197504e-02 1.47313912747197504e-02 -1.47313912747197504e-02 -1.47313912747197504e-02 1.47313912747197504e-02 -1.47313912747197504e-02 1.47313912747197504e-02 5.89255650988789806e-02 -5.89255650988789806e-02 0.00000000000000000e+00 0.00000000000000000e+00 -5.89255650988789875e-02 5.89255650988789875e-02 0.00000000000000000e+00 0.00000000000000000e+00 9.75781955236953991e-19 -1.21972744404619249e-18 6.09863722023096244e-19 1.06726151354041843e-19 0.00000000000000000e+00 -4.87890977618476995e-19 0.00000000000000000e+00 0.00000000000000000e+00 3.90312782094781596e-18 -3.90312782094781596e-18 1.95156391047390798e-18 -9.82092751647983819e-03 9.82092751647983646e-03 -9.82092751647983646e-03 9.82092751647983646e-03 -9.82092751647983646e-03 9.82092751647983472e-03 -9.82092751647983819e-03 9.82092751647983646e-03 -3.92837100659193320e-02 3.92837100659193320e-02 0.00000000000000000e+00 0.00000000000000000e+00 -3.92837100659193320e-02 3.92837100659193320e-02 0.00000000000000000e+00 0.00000000000000000e+00 1.96418550329596556e-02 -1.96418550329596556e-02 1.96418550329596556e-02 -1.96418550329596556e-02 7.85674201318386223e-02 -7.85674201318386362e-02 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 6.50521303491302660e-18 1.47313912747197538e-02 -1.47313912747197538e-02 -1.47313912747197538e-02 1.47313912747197538e-02 1.47313912747197538e-02 -1.47313912747197538e-02 -1.47313912747197538e-02 1.47313912747197538e-02 -6.09863722023096244e-19 -2.05829006182794982e-18 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 -1.70761842166466948e-18 0.00000000000000000e+00 0.00000000000000000e+00 5.89255650988790014e-02 -5.89255650988790014e-02 -5.89255650988790014e-02 5.89255650988789875e-02 0.00000000000000000e+00 -9.75781955236953991e-19 0.00000000000000000e+00 0.00000000000000000e+00 -2.43945488809238498e-19 0.00000000000000000e+00 0.00000000000000000e+00 -4.41941738241592649e-02 4.41941738241592649e-02 4.41941738241592580e-02 -4.41941738241592649e-02 4.41941738241592580e-02 -4.41941738241592580e-02 -4.41941738241592649e-02 4.41941738241592649e-02 1.09775469964157324e-18 -1.14349447879330546e-18 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 -2.92734586571086197e-18 2.92734586571086197e-18 4.39101879856629296e-18 -4.07084034450416743e-18 0.00000000000000000e+00 1.28071381624850211e-18 0.00000000000000000e+00 0.00000000000000000e+00 -1.64663204946235986e-18 1.46367293285543099e-18 -7.31836466427715493e-19 2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395042e-02 2.94627825494395042e-02 2.94627825494395111e-02 -2.94627825494395042e-02 -2.94627825494395111e-02 2.94627825494395042e-02 6.09863722023096244e-19 5.71747239396652729e-19 0.00000000000000000e+00 0.00000000000000000e+00 2.43945488809238498e-18 -1.21972744404619249e-18 0.00000000000000000e+00 0.00000000000000000e+00 -5.89255650988789736e-02 5.89255650988789806e-02 5.89255650988789806e-02 -5.89255650988789806e-02 0.00000000000000000e+00 2.43945488809238498e-18 0.00000000000000000e+00 0.00000000000000000e+00 7.62329652528870305e-19 1.21972744404619249e-18 0.00000000000000000e+00 -9.82092751647983819e-03 9.82092751647983646e-03 -9.82092751647983646e-03 9.82092751647983646e-03 -9.82092751647983646e-03 9.82092751647983472e-03 -9.82092751647983819e-03 9.82092751647983646e-03 1.96418550329596556e-02 -1.96418550329596556e-02 0.00000000000000000e+00 0.00000000000000000e+00 1.96418550329596556e-02 -1.96418550329596556e-02 0.00000000000000000e+00 0.00000000000000000e+00 -3.92837100659193320e-02 3.92837100659193320e-02 -3.92837100659193389e-02 3.92837100659193389e-02 7.85674201318386223e-02 -7.85674201318386362e-02 0.00000000000000000e+00 0.00000000000000000e+00 -3.25260651745651330e-18 -3.25260651745651330e-18 6.50521303491302660e-18 2.94627825494395042e-02 -2.94627825494395042e-02 2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395111e-02 2.94627825494395042e-02 -2.94627825494395111e-02 2.94627825494395042e-02 -5.89255650988789736e-02 5.89255650988789736e-02 0.00000000000000000e+00 0.00000000000000000e+00 5.89255650988789736e-02 -5.89255650988789598e-02 0.00000000000000000e+00 0.00000000000000000e+00 2.43945488809238498e-18 -3.65918233213857746e-18 4.57397791517322183e-18 -5.45065701558142268e-18 0.00000000000000000e+00 1.21972744404619249e-18 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 -1.96418550329596660e-02 1.96418550329596660e-02 -1.96418550329596729e-02 1.96418550329596729e-02 -1.96418550329596729e-02 1.96418550329596729e-02 -1.96418550329596660e-02 1.96418550329596660e-02 3.92837100659193250e-02 -3.92837100659193250e-02 0.00000000000000000e+00 0.00000000000000000e+00 3.92837100659193181e-02 -3.92837100659193181e-02 0.00000000000000000e+00 0.00000000000000000e+00 3.92837100659193181e-02 -3.92837100659193181e-02 3.92837100659193181e-02 -3.92837100659193181e-02 -7.85674201318386362e-02 7.85674201318386223e-02 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 0.00000000000000000e+00 3.27364250549327896e-03 3.27364250549327896e-03 3.27364250549327766e-03 3.27364250549327766e-03 3.27364250549327723e-03 3.27364250549327766e-03 3.27364250549327853e-03 3.27364250549327896e-03 1.30945700219731089e-02 1.30945700219731089e-02 -6.54728501098655186e-03 -6.54728501098655186e-03 1.30945700219731089e-02 1.30945700219731089e-02 -6.54728501098655186e-03 -6.54728501098655446e-03 1.30945700219731089e-02 1.30945700219731089e-02 1.30945700219731089e-02 1.30945700219731089e-02 5.23782800878924287e-02 5.23782800878924287e-02 -2.61891400439462074e-02 -2.61891400439462074e-02 -2.61891400439462074e-02 -2.61891400439462144e-02 -1.04756560175784830e-01 -9.82092751647983472e-03 -9.82092751647983299e-03 -9.82092751647983299e-03 -9.82092751647983299e-03 9.82092751647983299e-03 9.82092751647983125e-03 9.82092751647983125e-03 9.82092751647982952e-03 -3.92837100659193250e-02 -3.92837100659193250e-02 1.96418550329596556e-02 1.96418550329596590e-02 3.92837100659193250e-02 3.92837100659193250e-02 -1.96418550329596590e-02 -1.96418550329596590e-02 -8.13151629364128326e-19 -7.11507675693612285e-19 -9.14795583034644366e-19 -8.89384594617015356e-19 0.00000000000000000e+00 -3.25260651745651330e-18 -2.43945488809238498e-18 -3.25260651745651330e-18 7.85674201318386500e-02 -7.85674201318386500e-02 1.30104260698260532e-17 6.54728501098655272e-03 6.54728501098655272e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655619e-03 6.54728501098655446e-03 6.54728501098655446e-03 2.61891400439462248e-02 2.61891400439462248e-02 -1.30945700219731089e-02 -1.30945700219731037e-02 2.61891400439462248e-02 2.61891400439462248e-02 -1.30945700219731037e-02 -1.30945700219731089e-02 -1.30945700219730985e-02 -1.30945700219731037e-02 -1.30945700219730985e-02 -1.30945700219731002e-02 -5.23782800878924149e-02 -5.23782800878924149e-02 2.61891400439462178e-02 2.61891400439462178e-02 -5.23782800878924218e-02 -5.23782800878924149e-02 1.04756560175784830e-01 -9.82092751647983472e-03 -9.82092751647983646e-03 9.82092751647983646e-03 9.82092751647983646e-03 -9.82092751647983646e-03 -9.82092751647983472e-03 9.82092751647983819e-03 9.82092751647983646e-03 2.03287907341032081e-19 -6.47980204649539759e-19 1.96418550329596556e-02 -1.96418550329596556e-02 0.00000000000000000e+00 8.13151629364128326e-19 1.96418550329596590e-02 -1.96418550329596556e-02 -3.92837100659193320e-02 -3.92837100659193320e-02 3.92837100659193389e-02 3.92837100659193389e-02 0.00000000000000000e+00 4.06575814682064163e-19 7.85674201318386223e-02 -7.85674201318386362e-02 0.00000000000000000e+00 2.43945488809238498e-18 6.50521303491302660e-18 2.94627825494395042e-02 2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395042e-02 -2.94627825494395111e-02 2.94627825494395042e-02 2.94627825494395042e-02 6.09863722023096244e-19 1.86770764869573225e-18 -5.89255650988789736e-02 5.89255650988789736e-02 2.43945488809238498e-18 1.21972744404619249e-18 5.89255650988789736e-02 -5.89255650988789736e-02 7.31836466427715493e-18 6.09863722023096244e-18 -3.96411419315012559e-18 -3.01120212748903771e-18 -1.21972744404619249e-18 1.52465930505774061e-18 -1.21972744404619249e-18 0.00000000000000000e+00 0.00000000000000000e+00 -6.09863722023096244e-18 0.00000000000000000e+00 -1.96418550329596660e-02 -1.96418550329596660e-02 1.96418550329596660e-02 1.96418550329596660e-02 -1.96418550329596729e-02 -1.96418550329596729e-02 1.96418550329596729e-02 1.96418550329596729e-02 0.00000000000000000e+00 4.12928561786471415e-19 3.92837100659193250e-02 -3.92837100659193250e-02 0.00000000000000000e+00 5.08219768352580203e-19 3.92837100659193181e-02 -3.92837100659193250e-02 3.92837100659193181e-02 3.92837100659193181e-02 -3.92837100659193181e-02 -3.92837100659193181e-02 0.00000000000000000e+00 -1.01643953670516041e-18 -7.85674201318386084e-02 7.85674201318386362e-02 0.00000000000000000e+00 -3.04931861011548122e-18 0.00000000000000000e+00 6.54728501098655272e-03 6.54728501098655272e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655446e-03 6.54728501098655619e-03 6.54728501098655446e-03 6.54728501098655446e-03 -1.30945700219731002e-02 -1.30945700219731037e-02 -1.30945700219731002e-02 -1.30945700219731002e-02 -1.30945700219731002e-02 -1.30945700219731002e-02 -1.30945700219731002e-02 -1.30945700219731037e-02 2.61891400439462248e-02 2.61891400439462248e-02 2.61891400439462248e-02 2.61891400439462248e-02 -5.23782800878924149e-02 -5.23782800878924149e-02 -5.23782800878924010e-02 -5.23782800878924149e-02 2.61891400439462282e-02 2.61891400439462178e-02 1.04756560175784830e-01 -1.96418550329596660e-02 -1.96418550329596660e-02 -1.96418550329596660e-02 -1.96418550329596660e-02 1.96418550329596729e-02 1.96418550329596729e-02 1.96418550329596729e-02 1.96418550329596729e-02 3.92837100659193181e-02 3.92837100659193111e-02 3.92837100659193181e-02 3.92837100659193181e-02 -3.92837100659193181e-02 -3.92837100659193181e-02 -3.92837100659193181e-02 -3.92837100659193111e-02 -4.06575814682064163e-18 -4.57397791517322183e-18 -3.81164826264435153e-18 -4.47868670860711304e-18 0.00000000000000000e+00 0.00000000000000000e+00 -4.06575814682064163e-18 0.00000000000000000e+00 -7.85674201318386500e-02 7.85674201318386917e-02 0.00000000000000000e+00 1.30945700219731176e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731159e-02 1.30945700219731141e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462178e-02 -2.61891400439462109e-02 -2.61891400439462074e-02 -2.61891400439462074e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462109e-02 -2.61891400439462074e-02 5.23782800878923802e-02 5.23782800878923940e-02 5.23782800878923940e-02 5.23782800878923940e-02 5.23782800878924218e-02 5.23782800878924495e-02 -1.04756560175784899e-01 2 27 27
 DEAL:3d::OK

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.