]> https://gitweb.dealii.org/ - dealii.git/commitdiff
New test cases
authorMartin Kronbichler <martin.kronbichler@rub.de>
Wed, 13 Mar 2024 21:16:26 +0000 (22:16 +0100)
committerMartin Kronbichler <martin.kronbichler@rub.de>
Fri, 15 Mar 2024 06:12:30 +0000 (07:12 +0100)
tests/lac/gmres_reorthogonalize_06.cc [new file with mode: 0644]
tests/lac/gmres_reorthogonalize_06.output [new file with mode: 0644]
tests/lac/solver_gmres_03.cc [new file with mode: 0644]
tests/lac/solver_gmres_03.output [new file with mode: 0644]
tests/lac/solver_gmres_04.cc [new file with mode: 0644]
tests/lac/solver_gmres_04.output [new file with mode: 0644]

diff --git a/tests/lac/gmres_reorthogonalize_06.cc b/tests/lac/gmres_reorthogonalize_06.cc
new file mode 100644 (file)
index 0000000..b61515c
--- /dev/null
@@ -0,0 +1,158 @@
+// ------------------------------------------------------------------------
+//
+// SPDX-License-Identifier: LGPL-2.1-or-later
+// Copyright (C) 2013 - 2023 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// Part of the source code is dual licensed under Apache-2.0 WITH
+// LLVM-exception OR LGPL-2.1-or-later. Detailed license information
+// governing the source code and code contributions can be found in
+// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
+//
+// ------------------------------------------------------------------------
+
+
+// tests that GMRES builds an orthonormal basis properly for a few difficult
+// test matrices for the delayed classical Gram-Schmidt method. As opposed to
+// the gmres_reorthogonalize_xx tests, this test ensures that no
+// reorthogonalization is performed for that variant (because it is done
+// unconditionally) and that the Hessenberg matrix is highly accurate.
+
+#include <deal.II/lac/full_matrix.h>
+#include <deal.II/lac/precondition.h>
+#include <deal.II/lac/solver_gmres.h>
+#include <deal.II/lac/vector.h>
+
+#include "../tests.h"
+
+
+
+template <typename number>
+void
+test(unsigned int variant, unsigned int min_convergence_steps)
+{
+  const unsigned int n = 64;
+  Vector<number>     rhs(n), sol(n);
+  rhs = 1.;
+
+  FullMatrix<number> matrix(n, n);
+  for (unsigned int i = 0; i < n; ++i)
+    for (unsigned int j = 0; j < n; ++j)
+      matrix(i, j) = random_value<double>(-.1, .1);
+
+  // put diagonal entries of different strengths. these are very challenging
+  // for GMRES and will usually take a lot of iterations until the Krylov
+  // subspace is complete enough
+  if (variant == 0)
+    for (unsigned int i = 0; i < n; ++i)
+      matrix(i, i) = (i + 1);
+  else if (variant == 1)
+    for (unsigned int i = 0; i < n; ++i)
+      matrix(i, i) = (i + 1) * (i + 1) * (i + 1) * (i + 1);
+  else if (variant == 2)
+    for (unsigned int i = 0; i < n; ++i)
+      matrix(i, i) = 1e10 * (i + 1);
+  else if (variant == 3)
+    for (unsigned int i = 0; i < n; ++i)
+      matrix(i, i) = 1e10 * (i + 1) * (i + 1) * (i + 1) * (i + 1);
+  else if (variant == 4)
+    for (unsigned int i = 0; i < n; ++i)
+      matrix(i, i) = 1e30 * (i + 1);
+  else if (variant == 5)
+    for (unsigned int i = 0; i < n; ++i)
+      matrix(i, i) = 1e30 * (i + 1) * (i + 1) * (i + 1) * (i + 1);
+  else
+    Assert(false, ExcMessage("Invalid variant"));
+  if (std::is_same_v<number, float> == true)
+    Assert(variant < 4, ExcMessage("Invalid_variant"));
+
+  deallog.push(Utilities::int_to_string(variant, 1));
+
+  SolverControl control(1000, 5e2 * std::numeric_limits<number>::epsilon());
+  typename SolverGMRES<Vector<number>>::AdditionalData data;
+  data.max_basis_size = min_convergence_steps + 2;
+  data.orthogonalization_strategy =
+    LinearAlgebra::OrthogonalizationStrategy::delayed_classical_gram_schmidt;
+
+  SolverGMRES<Vector<number>> solver(control, data);
+  auto print_re_orthogonalization = [](int accumulated_iterations) {
+    deallog.get_file_stream() << "Re-orthogonalization enabled at step "
+                              << accumulated_iterations << std::endl;
+  };
+
+  auto print_hessenberg_matrix = [](const FullMatrix<double> &H) {
+    deallog.get_file_stream() << "Scaled Hessenberg matrix" << std::endl;
+    // Print the first 30 entries in the Hessenberg matrix
+    for (unsigned int i = 0; i < 30; ++i)
+      {
+        for (unsigned int j = 0; j < 30; ++j)
+          {
+            if (std::abs(H(i, j) / H(0, 0)) >
+                (std::is_same_v<number, float> ? 1e-6 : 1e-12))
+              deallog.get_file_stream() << H(i, j) / H(0, 0) << " ";
+            else
+              deallog.get_file_stream() << "0 ";
+          }
+        deallog.get_file_stream() << std::endl;
+      }
+  };
+
+  auto print_orthogonality =
+    [](const internal::SolverGMRESImplementation::TmpVectors<Vector<number>>
+         &tmp_vector) {
+      deallog.get_file_stream() << "Orthogonality quality" << std::endl;
+      for (unsigned int i = 0; i < tmp_vector.size() - 3; ++i)
+        {
+          if (const_cast<internal::SolverGMRESImplementation::TmpVectors<
+                Vector<number>> &>(tmp_vector)(i, {})
+                .size() > 0)
+            {
+              for (unsigned int j = 0; j <= i; ++j)
+                {
+                  const double product = tmp_vector[i] * tmp_vector[j];
+                  if (std::abs(product) >
+                      (std::is_same_v<number, float> ? 5e-7 : 1e-12))
+                    deallog.get_file_stream() << product << " ";
+                  else
+                    deallog.get_file_stream() << "0 ";
+                }
+              deallog.get_file_stream() << std::endl;
+            }
+        }
+    };
+
+  if (std::is_same_v<number, double> && variant < 4)
+    solver.connect_hessenberg_slot(print_hessenberg_matrix);
+  solver.connect_krylov_space_slot(print_orthogonality);
+
+  check_solver_within_range(
+    solver.solve(matrix, sol, rhs, PreconditionIdentity()),
+    control.last_step(),
+    min_convergence_steps,
+    min_convergence_steps + 2);
+
+  deallog.pop();
+}
+
+int
+main()
+{
+  initlog();
+  deallog << std::setprecision(10);
+
+  deallog.push("double");
+  test<double>(0, 56);
+  test<double>(1, 64);
+  test<double>(2, 56);
+  test<double>(3, 64);
+  test<double>(4, 56);
+  test<double>(5, 64);
+  deallog.pop();
+  deallog.push("float");
+  test<float>(0, 34);
+  test<float>(1, 64);
+  test<float>(2, 34);
+  test<float>(3, 64);
+  deallog.pop();
+}
diff --git a/tests/lac/gmres_reorthogonalize_06.output b/tests/lac/gmres_reorthogonalize_06.output
new file mode 100644 (file)
index 0000000..7526461
--- /dev/null
@@ -0,0 +1,701 @@
+
+Scaled Hessenberg matrix
+1.00000 0.569890 -0.00156039 0.000549463 0.00414993 0.00238574 0.00352334 1.77878e-05 -0.00221015 -1.05609e-05 -2.03863e-05 0.00152720 0.00482166 -0.000753156 -0.000393766 0.00137832 0.00138838 0.00171731 -0.00439883 -0.000701780 0.00409495 -0.00216811 0.00740867 0.00107744 0.00329879 -0.00195437 0.000781132 0.00321206 0.000990544 0.00250136 
+0.567471 1.00365 0.507022 -0.00287199 -0.000428082 -0.00225300 0.000962302 0.00329954 0.000829040 -0.000283791 0.00327355 0.00290848 0.000479410 -0.000332711 -7.16323e-05 0.00290838 -0.00257815 -0.00404140 0.000607781 0.00112666 -0.000441412 0.00494777 -0.000900166 0.00306813 -0.00185017 -0.00509404 0.000395130 2.85973e-05 -0.00327067 -0.000660711 
+0 0.508049 1.00695 0.499030 0.000443025 0.00193504 0.00142847 -0.00317394 0.00133570 -7.69360e-05 -0.000307488 -0.000671495 -0.000232718 -0.00214986 0.00193547 0.000138859 -0.00184527 0.00462843 -0.00539517 0.00193362 -0.000480487 -0.00305234 -0.000275440 0.00168768 0.00183367 0.000337904 0.00529845 -0.00310515 0.00181036 -0.000335422 
+0 0 0.497961 0.995509 0.494699 -0.00576223 -0.000948244 0.00256600 -0.00232714 0.00196006 0.00461623 0.00132160 0.00754430 0.000291849 0.000107463 -0.00306505 3.99411e-05 0.00161910 -0.000472771 0.00344227 0.000722215 -0.00166065 0.00417640 -5.97640e-05 0.00245594 0.00308245 0.000876099 -0.00580185 -0.00175529 -0.000338322 
+0 0 0 0.495447 1.00049 0.493347 -0.00160942 -0.00235425 -0.000777976 0.00689908 0.000215414 -0.000976030 -0.000313701 -0.000798832 -0.00112796 -0.000879436 0.000324047 -0.00113025 0.00584908 0.00110977 0.00135354 0.00277197 -6.01027e-05 -0.00169658 0.00284468 0.00142873 -0.00570784 0.00374856 0.00127485 0.00320946 
+0 0 0 0 0.488166 1.00041 0.495215 -4.77641e-05 0.000789093 -0.00282171 -0.00180451 0.00344977 -0.00123371 0.00428849 0.00148632 0.00110530 -0.00710490 -0.00250015 0.00267782 -0.00151787 0.00100076 0.000352449 0.00173963 0.000352199 0.000237016 -0.00316810 0.00382086 -0.00135878 0.000236215 -0.00210911 
+0 0 0 0 0 0.493432 0.998184 0.485267 -0.00338306 -0.00243257 -0.00212945 -0.00165042 -0.00216629 0.000511550 -0.00185728 0.00397255 0.00405181 -0.00182964 0.00304983 0.00452060 4.36329e-05 0.00560270 -0.00487096 0.00121624 -0.000172457 -0.000474446 0.00331896 0.00401574 0.000136703 0.00169433 
+0 0 0 0 0 0 0.488781 0.993861 0.490958 0.00304397 0.00497950 -0.000361559 0.00162422 0.00181248 -0.00110030 0.00224373 0.000402342 0.000612016 -0.00128572 0.00106427 0.000738254 -0.000115983 -0.000351607 -0.00432742 0.00252448 7.33779e-05 -0.00337856 -0.00124075 -0.00128084 0.00176542 
+0 0 0 0 0 0 0 0.489337 0.993112 0.484680 -0.00210849 -0.000261371 -0.00113881 0.000599100 0.000574508 0.00263647 -0.00443925 0.000903032 -5.22245e-05 -0.00252826 0.00366006 0.00414987 -0.000354359 0.00158835 -0.00278297 0.000116637 0.00174746 0.00102479 -0.00380339 -0.00347214 
+0 0 0 0 0 0 0 0 0.484378 1.02249 0.486121 -0.00332325 0.00284797 0.00382955 0.00305512 0.000156227 -0.00198918 0.000725433 -0.00445137 0.00574521 -0.000844454 -0.00234764 -0.00190314 -0.00281351 -0.00481042 0.00326204 -0.000194230 0.00289972 0.00369295 0.00197519 
+0 0 0 0 0 0 0 0 0 0.488794 0.997061 0.485088 0.00319609 -0.000489741 0.00145436 -0.000718014 -0.00492722 0.00312391 0.000585121 0.000970030 0.00167843 0.00363024 0.00272103 -0.00571633 0.000462634 0.000915257 -0.00124095 -0.00368450 -0.00145491 -0.00459897 
+0 0 0 0 0 0 0 0 0 0 0.482705 0.969766 0.486284 0.00249767 0.000412089 -0.00303732 0.00398381 -0.000270478 -0.000424552 0.000388032 0.000220482 -0.00122473 0.00366448 0.00283603 -0.00305825 -0.00220883 -0.00120375 -0.00399455 -0.000791512 0.000945324 
+0 0 0 0 0 0 0 0 0 0 0 0.489119 1.00075 0.475992 -0.00282655 -0.000814059 -0.00270194 -0.00248245 0.00353695 0.000171174 0.00107416 -0.00212172 -0.000756260 -0.00406230 -0.000947944 0.000675035 0.000633593 0.00173223 -0.00421283 -0.00133460 
+0 0 0 0 0 0 0 0 0 0 0 0 0.473608 1.03533 0.473520 -0.00327590 0.00195859 0.00273407 0.00249079 -0.00410044 -0.00417074 0.00543818 0.00393823 -0.00332274 -0.00376885 -0.00298001 0.00233061 0.00254866 -6.10379e-05 0.00175311 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0.478340 1.00723 0.485225 0.00177280 -0.00149980 -0.00149595 0.000194338 -0.00338089 -0.00227723 -0.00271682 -0.000283960 0.000582281 -0.000750198 -0.00241044 -4.92286e-05 0.00127716 -0.00230711 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.487966 1.00327 0.478242 0.00413214 -0.00204304 0.00108017 0.00128452 -0.000882287 0.000323040 -0.000261397 0.00335053 0.000835885 0.00223032 -0.000667635 -0.00126214 0.000154828 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.472714 1.00034 0.487880 -0.00209578 -0.00245070 0.000324394 -0.000557940 0.00173485 0.00326498 0.00382025 -0.00318869 -0.000469847 0.00309653 0.000568744 0.000445532 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.487289 0.973851 0.467697 0.00128435 -0.000288432 -0.000460877 0.000842368 -0.00229326 0.00161190 0.00124148 -0.000475820 0.00513684 0.00184289 8.70713e-05 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.471584 1.01123 0.477188 -0.00191934 0.00393712 0.000514815 -1.49833e-05 -0.00123697 -0.00290024 -0.00357709 0.000509850 0.000964235 0.000767961 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.478905 1.00256 0.461363 -0.000655421 -0.000873221 -0.00307968 -0.00320407 0.000340809 0.00210041 -0.000167722 -0.00235651 -0.00256641 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.465703 0.989279 0.464814 -3.20312e-05 0.00376631 -0.00318061 0.00368285 0.00545916 -0.000259255 0.000744807 -0.00223632 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.460792 1.00076 0.455712 -0.00130349 0.00199893 -0.000732962 -0.00427527 -0.00112827 -0.00282780 -0.00264227 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.453690 1.01841 0.447960 -0.00315885 0.00121799 0.00381101 -0.00369275 0.00213681 0.000412072 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.447680 1.01688 0.466864 -0.00173670 -0.000585613 -0.00279937 -0.000479406 0.00845358 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.466149 0.999008 0.458022 0.00257980 0.000712045 -0.00240797 0.00273302 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.458281 0.999018 0.442956 0.00184084 -0.000505318 -0.00263035 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.444463 1.00337 0.444350 0.00714303 -0.00355506 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.445126 1.01426 0.441082 -0.00313075 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.437850 0.985582 0.452904 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.448207 1.00507 
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:double:0::Solver stopped within 56 - 58 iterations
+Scaled Hessenberg matrix
+1.00000 1.32490 -9.49818e-09 5.37056e-08 -2.28922e-08 1.49582e-08 -4.43643e-08 -1.19335e-08 4.78270e-08 -1.81364e-08 -4.15097e-08 -4.63999e-08 2.84918e-08 3.06400e-08 -1.33537e-09 -1.37939e-08 -2.23336e-09 -4.49272e-08 -4.01071e-08 -2.30300e-08 1.86161e-08 -2.50720e-09 -1.55721e-08 -1.86029e-08 6.04196e-09 4.54352e-08 -6.10338e-09 9.37710e-09 -5.66384e-08 2.07374e-08 
+1.32490 2.81826 1.23185 1.28995e-08 -7.89872e-09 -1.16532e-08 -1.66145e-09 -1.00124e-09 -2.53751e-08 -3.02150e-08 2.59864e-09 -1.44258e-08 -5.15823e-08 2.03384e-08 5.71558e-09 -3.50508e-09 1.05568e-08 -8.92470e-09 -1.13938e-08 3.87507e-09 1.45102e-10 9.72211e-09 -4.77873e-09 -1.57956e-08 7.46847e-09 2.44232e-08 1.45368e-08 2.61800e-09 2.28500e-09 -4.19579e-08 
+0 1.23185 2.55087 1.22997 2.47521e-08 -2.09637e-08 3.61206e-08 1.57814e-08 -2.16056e-08 -3.91431e-09 -2.49746e-08 -1.25421e-08 -3.53165e-08 1.45925e-08 -3.73198e-08 1.97750e-08 -1.38555e-08 -1.82210e-08 1.60533e-08 -3.57525e-08 6.08943e-09 -1.44070e-08 -3.87232e-08 5.05707e-08 2.73465e-08 -1.06611e-08 9.38383e-09 2.23531e-08 -4.03240e-08 -2.20622e-09 
+0 0 1.22997 2.49373 1.22365 2.92986e-08 4.49943e-09 -8.11864e-08 -3.76726e-08 4.49762e-09 2.41455e-08 -1.21324e-08 -4.72465e-08 4.00759e-09 -1.41165e-08 -3.11792e-08 -8.87159e-09 -8.59222e-09 -2.19950e-08 -1.14657e-08 -4.78394e-08 -5.04806e-08 1.82382e-08 -1.42951e-08 -3.45377e-08 -2.94866e-08 -3.15381e-08 -6.23609e-09 -1.40614e-09 1.28508e-08 
+0 0 0 1.22365 2.46092 1.21439 5.14421e-09 -4.63844e-09 -3.24202e-08 -2.16462e-08 -2.81587e-08 -1.73234e-08 -5.83814e-09 1.89579e-08 4.80328e-08 -1.84381e-08 -8.24323e-09 -3.14204e-08 1.08491e-08 -1.21067e-08 -2.50410e-08 -3.21365e-08 -9.12927e-09 1.05736e-08 -2.07477e-08 -2.26832e-08 3.58600e-08 -4.24572e-08 -1.96043e-08 -1.65371e-08 
+0 0 0 0 1.21439 2.43186 1.20262 -1.54324e-08 4.55062e-09 3.98404e-08 1.48758e-09 4.17784e-08 1.10394e-08 2.55427e-08 2.51855e-08 -1.72738e-08 5.81214e-09 2.60954e-08 -8.48995e-09 7.09276e-09 -2.33639e-09 -4.61995e-08 -1.95232e-08 -1.26066e-08 -1.17163e-08 2.33911e-08 3.24640e-08 4.81049e-09 -3.57339e-08 -1.17331e-08 
+0 0 0 0 0 1.20262 2.40159 1.18851 -2.68347e-09 2.52530e-08 2.12843e-08 -8.46413e-09 -1.12770e-08 1.21600e-08 -2.34700e-08 2.24989e-08 -8.72852e-09 2.94604e-09 3.35059e-08 3.59937e-08 -1.25425e-08 -3.29074e-08 -2.52164e-08 3.98393e-08 5.49892e-09 1.17417e-08 -2.47173e-08 1.84252e-08 1.32963e-08 1.43508e-08 
+0 0 0 0 0 0 1.18851 2.36845 1.17215 1.73850e-09 -1.02492e-08 1.45979e-08 -1.45196e-08 -2.44172e-08 -2.24234e-08 -2.81075e-08 -1.22262e-08 -2.04224e-08 6.59974e-09 -4.36507e-08 -1.74604e-08 -1.93436e-08 1.87436e-08 -1.85638e-08 2.22452e-08 2.12327e-08 -1.59459e-08 2.03667e-08 -2.52994e-08 4.92681e-08 
+0 0 0 0 0 0 0 1.17215 2.33186 1.15364 1.41364e-08 -2.41068e-09 2.76919e-08 7.24955e-09 -3.81550e-08 -4.97258e-08 2.83202e-08 8.52763e-09 2.39561e-09 1.86503e-08 -4.29086e-08 8.45375e-09 -2.22254e-08 1.08253e-08 3.30713e-08 2.38319e-08 -1.23615e-08 1.08523e-08 1.45750e-08 -2.54209e-08 
+0 0 0 0 0 0 0 0 1.15364 2.29158 1.13307 -9.44662e-09 8.11518e-09 1.36838e-08 -1.57860e-08 -3.66540e-08 -4.40010e-10 1.78342e-08 -4.10987e-10 1.08885e-08 3.61406e-08 -1.88270e-08 -8.30371e-09 8.91427e-09 -6.00369e-09 -2.65004e-08 -1.40857e-08 -1.21918e-08 1.97772e-08 -1.26953e-09 
+0 0 0 0 0 0 0 0 0 1.13307 2.24759 1.11052 4.95700e-09 7.18745e-09 -4.62338e-08 2.92715e-08 4.15200e-08 -9.91620e-10 2.76311e-08 4.30857e-10 -1.69520e-08 2.02434e-08 -6.18649e-08 2.97537e-08 -4.50421e-09 -1.21733e-08 2.45805e-08 1.74466e-08 -1.58370e-08 3.06306e-09 
+0 0 0 0 0 0 0 0 0 0 1.11052 2.19995 1.08608 1.73518e-08 -1.46423e-08 4.03729e-09 -2.20880e-08 -5.12228e-08 -3.29355e-08 8.16382e-09 3.80970e-08 -1.65571e-09 1.77126e-10 8.86736e-09 -1.39406e-09 2.76540e-09 1.13381e-08 2.66572e-08 2.20720e-08 2.68319e-10 
+0 0 0 0 0 0 0 0 0 0 0 1.08608 2.14879 1.05985 -7.29389e-09 -2.07638e-08 -6.49522e-09 1.08271e-08 7.19586e-09 -1.53797e-08 3.18859e-08 2.06475e-08 -3.43989e-08 2.84171e-08 3.65902e-08 -1.21868e-08 -2.49958e-09 2.76564e-08 -6.28215e-09 3.01517e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 1.05985 2.09426 1.03194 5.10316e-11 -6.52325e-09 3.43549e-08 -1.41910e-08 2.12764e-09 5.85856e-09 1.37750e-08 1.71430e-08 3.78764e-08 -5.66578e-08 1.76868e-09 4.71014e-09 -1.28269e-08 -2.95783e-09 4.25791e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.03194 2.03655 1.00246 -1.62030e-08 7.00152e-09 -3.89584e-08 -6.76831e-09 -6.57155e-09 -4.97141e-10 -1.02515e-08 -7.19762e-08 -2.42527e-08 7.32890e-09 -1.35731e-08 -2.43633e-08 -3.57053e-08 2.53728e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00246 1.97589 0.971536 5.94556e-08 -3.84616e-08 -1.64576e-09 -1.14244e-08 -2.67734e-08 2.80186e-08 -7.69318e-12 -7.98912e-09 -1.95741e-08 2.01784e-08 5.48425e-08 -1.28669e-08 -1.46135e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.971536 1.91249 0.939283 -3.82853e-09 3.67144e-09 -2.78868e-08 -1.85357e-08 2.22794e-10 -1.79659e-08 1.16745e-08 -1.48300e-08 -3.52597e-08 2.72499e-08 2.05664e-08 -6.33757e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.939283 1.84660 0.905836 -5.59910e-08 -7.25965e-09 1.33653e-08 1.39425e-08 5.68286e-09 1.09224e-08 -2.02002e-08 -2.39984e-08 -1.42330e-08 4.64723e-08 -3.78061e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.905836 1.77849 0.871332 -6.56328e-09 -1.53762e-09 -3.68824e-09 9.32880e-09 2.08473e-08 4.35414e-08 2.62386e-08 2.25977e-08 -5.24871e-09 3.45022e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.871332 1.70842 0.835913 9.64006e-09 1.42841e-08 -2.18283e-09 -5.71858e-09 -1.05118e-08 7.06545e-09 3.66054e-08 2.07915e-08 6.69885e-09 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.835913 1.63669 0.799725 -5.72860e-09 2.31409e-09 4.90222e-09 -2.74515e-09 2.64946e-08 -1.89110e-08 -1.33092e-08 -5.51575e-09 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.799725 1.56358 0.762918 -5.21056e-09 -1.10212e-08 -1.84690e-08 5.90526e-09 2.06928e-08 1.19758e-08 6.74441e-09 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.762918 1.48940 0.725645 1.09637e-08 -2.63690e-08 1.72335e-08 -6.55037e-10 -9.04718e-09 8.24505e-09 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.725645 1.41444 0.688061 7.25303e-09 2.32214e-08 1.51268e-08 3.37939e-08 2.15200e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.688061 1.33904 0.650323 8.08681e-09 2.36005e-08 3.25948e-08 7.31899e-10 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.650323 1.26348 0.612590 -1.95140e-09 9.23576e-09 -1.97061e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.612590 1.18810 0.575018 1.87328e-08 2.34422e-08 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.575018 1.11321 0.537765 8.21733e-09 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.537765 1.03911 0.500984 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.500984 0.966109 
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:double:1::Solver stopped within 64 - 66 iterations
+Scaled Hessenberg matrix
+1.00000 0.568399 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0.568399 1.00000 0.508205 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0.508205 1.00000 0.498742 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0.498742 1.00000 0.495229 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0.495229 1.00000 0.493276 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0.493276 1.00000 0.491850 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0.491850 1.00000 0.490607 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0.490607 1.00000 0.489403 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0.489403 1.00000 0.488170 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0.488170 1.00000 0.486870 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0.486870 1.00000 0.485483 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0.485483 1.00000 0.483997 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0.483997 1.00000 0.482401 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0.482401 1.00000 0.480691 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0.480691 1.00000 0.478861 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.478861 1.00000 0.476908 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.476908 1.00000 0.474828 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.474828 1.00000 0.472618 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.472618 1.00000 0.470276 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.470276 1.00000 0.467798 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.467798 1.00000 0.465183 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.465183 1.00000 0.462426 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.462426 1.00000 0.459527 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.459527 1.00000 0.456481 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.456481 1.00000 0.453284 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.453284 1.00000 0.449935 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.449935 1.00000 0.446429 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.446429 1.00000 0.442763 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.442763 1.00000 0.438931 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.438931 1.00000 
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:double:2::Solver stopped within 56 - 58 iterations
+Scaled Hessenberg matrix
+1.00000 1.32490 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+1.32490 2.81826 1.23185 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 1.23185 2.55087 1.22997 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 1.22997 2.49373 1.22365 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 1.22365 2.46092 1.21439 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 1.21439 2.43186 1.20262 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 1.20262 2.40159 1.18851 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 1.18851 2.36845 1.17215 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 1.17215 2.33186 1.15364 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 1.15364 2.29158 1.13307 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 1.13307 2.24759 1.11052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 1.11052 2.19995 1.08608 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 1.08608 2.14879 1.05985 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 1.05985 2.09426 1.03194 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.03194 2.03655 1.00246 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00246 1.97589 0.971536 0 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.971536 1.91249 0.939283 0 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.939283 1.84660 0.905836 0 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.905836 1.77849 0.871332 0 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.871332 1.70842 0.835913 0 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.835913 1.63669 0.799725 0 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.799725 1.56358 0.762918 0 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.762918 1.48940 0.725645 0 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.725645 1.41444 0.688061 0 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.688061 1.33904 0.650323 0 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.650323 1.26348 0.612590 0 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.612590 1.18810 0.575018 0 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.575018 1.11321 0.537765 0 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.537765 1.03911 0.500984 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.500984 0.966109 
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:double:3::Solver stopped within 64 - 66 iterations
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:double:4::Solver stopped within 56 - 58 iterations
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:double:5::Solver stopped within 64 - 66 iterations
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:float:0::Solver stopped within 34 - 36 iterations
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:float:1::Solver stopped within 64 - 66 iterations
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:float:2::Solver stopped within 34 - 36 iterations
+Orthogonality quality
+1.00000 
+0 1.00000 
+0 0 1.00000 
+0 0 0 1.00000 
+0 0 0 0 1.00000 
+0 0 0 0 0 1.00000 
+0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.00000 
+DEAL:float:3::Solver stopped within 64 - 66 iterations
diff --git a/tests/lac/solver_gmres_03.cc b/tests/lac/solver_gmres_03.cc
new file mode 100644 (file)
index 0000000..85fe793
--- /dev/null
@@ -0,0 +1,156 @@
+// ------------------------------------------------------------------------
+//
+// SPDX-License-Identifier: LGPL-2.1-or-later
+// Copyright (C) 2022 - 2023 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// Part of the source code is dual licensed under Apache-2.0 WITH
+// LLVM-exception OR LGPL-2.1-or-later. Detailed license information
+// governing the source code and code contributions can be found in
+// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
+//
+// ------------------------------------------------------------------------
+
+// Check the path of SolverGMRES with distributed vectors and
+// LinearAlgebra::OrthogonalizationStrategy::delayed_classical_gram_schmidt.
+
+
+#include <deal.II/lac/diagonal_matrix.h>
+#include <deal.II/lac/la_parallel_block_vector.h>
+#include <deal.II/lac/la_parallel_vector.h>
+#include <deal.II/lac/precondition.h>
+#include <deal.II/lac/solver_gmres.h>
+
+#include "../tests.h"
+
+
+struct MyDiagonalMatrix
+{
+  MyDiagonalMatrix(const LinearAlgebra::distributed::Vector<double> &diagonal)
+    : diagonal(diagonal)
+  {}
+
+  void
+  vmult(LinearAlgebra::distributed::Vector<double>       &dst,
+        const LinearAlgebra::distributed::Vector<double> &src) const
+  {
+    dst = src;
+    dst.scale(diagonal);
+  }
+
+  void
+  vmult(LinearAlgebra::distributed::BlockVector<double>       &dst,
+        const LinearAlgebra::distributed::BlockVector<double> &src) const
+  {
+    dst = src;
+    for (unsigned int b = 0; b < src.n_blocks(); ++b)
+      dst.block(0).scale(diagonal);
+  }
+
+  unsigned int
+  m() const
+  {
+    return diagonal.size();
+  }
+
+  const LinearAlgebra::distributed::Vector<double> &diagonal;
+};
+
+
+
+SolverControl::State
+monitor_norm(const unsigned int iteration,
+             const double       check_value,
+             const LinearAlgebra::distributed::Vector<double> &)
+{
+  deallog << "   estimated residual at iteration " << iteration << ": "
+          << check_value << std::endl;
+  return SolverControl::success;
+}
+
+
+
+SolverControl::State
+monitor_norm_block(const unsigned int iteration,
+                   const double       check_value,
+                   const LinearAlgebra::distributed::BlockVector<double> &)
+{
+  deallog << "   estimated residual at iteration " << iteration << ": "
+          << check_value << std::endl;
+  return SolverControl::success;
+}
+
+
+int
+main()
+{
+  initlog();
+
+  // Create diagonal matrix with entries between 1 and 30
+  LinearAlgebra::distributed::Vector<double> matrix_entries_(30);
+  matrix_entries_ = 1.0;
+  MyDiagonalMatrix unit_matrix(matrix_entries_);
+
+  LinearAlgebra::distributed::Vector<double> matrix_entries(unit_matrix.m());
+  for (unsigned int i = 0; i < unit_matrix.m(); ++i)
+    matrix_entries(i) = i + 1;
+  MyDiagonalMatrix matrix(matrix_entries);
+
+  LinearAlgebra::distributed::Vector<double> rhs(unit_matrix.m());
+  LinearAlgebra::distributed::Vector<double> sol(unit_matrix.m());
+  rhs = 1.;
+
+  {
+    deallog << "Solve with PreconditionIdentity: " << std::endl;
+    SolverControl control(40, 1e-4);
+    SolverGMRES<LinearAlgebra::distributed::Vector<double>>::AdditionalData
+      data3(6);
+    data3.orthogonalization_strategy =
+      LinearAlgebra::OrthogonalizationStrategy::delayed_classical_gram_schmidt;
+    SolverGMRES<LinearAlgebra::distributed::Vector<double>> solver(control,
+                                                                   data3);
+    solver.connect(&monitor_norm);
+    solver.solve(matrix, sol, rhs, PreconditionIdentity());
+    LinearAlgebra::distributed::Vector<double> vec(sol);
+    matrix.vmult(vec, sol);
+    vec -= rhs;
+    deallog << "True residual: " << vec.l2_norm() << std::endl;
+
+    deallog << "Solve with diagonal preconditioner: " << std::endl;
+    sol = 0;
+    solver.solve(matrix, sol, rhs, unit_matrix);
+    matrix.vmult(vec, sol);
+    vec -= rhs;
+    deallog << "True residual: " << vec.l2_norm() << std::endl;
+  }
+
+  {
+    LinearAlgebra::distributed::BlockVector<double> rhs_(1);
+    LinearAlgebra::distributed::BlockVector<double> sol_(1);
+    rhs_.block(0) = rhs;
+    sol_.block(0) = sol;
+
+    deallog << "Solve with PreconditionIdentity: " << std::endl;
+    SolverControl control(40, 1e-4);
+    SolverGMRES<LinearAlgebra::distributed::BlockVector<double>>::AdditionalData
+      data3(6);
+    data3.orthogonalization_strategy =
+      LinearAlgebra::OrthogonalizationStrategy::delayed_classical_gram_schmidt;
+    SolverGMRES<LinearAlgebra::distributed::BlockVector<double>> solver(control,
+                                                                        data3);
+    solver.connect(&monitor_norm_block);
+    solver.solve(matrix, sol_, rhs_, PreconditionIdentity());
+    LinearAlgebra::distributed::BlockVector<double> vec(sol_);
+    matrix.vmult(vec, sol_);
+    vec -= rhs_;
+    deallog << "True residual: " << vec.l2_norm() << std::endl;
+
+    deallog << "Solve with diagonal preconditioner: " << std::endl;
+    sol_ = 0;
+    solver.solve(matrix, sol_, rhs_, unit_matrix);
+    matrix.vmult(vec, sol_);
+    vec -= rhs_;
+    deallog << "True residual: " << vec.l2_norm() << std::endl;
+  }
+}
diff --git a/tests/lac/solver_gmres_03.output b/tests/lac/solver_gmres_03.output
new file mode 100644 (file)
index 0000000..9b16c8a
--- /dev/null
@@ -0,0 +1,141 @@
+
+DEAL::Solve with PreconditionIdentity: 
+DEAL:GMRES::Starting value 5.47723
+DEAL:GMRES::   estimated residual at iteration 0: 5.47723
+DEAL:GMRES::   estimated residual at iteration 1: 2.67042
+DEAL:GMRES::   estimated residual at iteration 2: 1.70538
+DEAL:GMRES::   estimated residual at iteration 3: 1.20190
+DEAL:GMRES::   estimated residual at iteration 4: 0.884567
+DEAL:GMRES::   estimated residual at iteration 5: 0.662215
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 7: 0.419909
+DEAL:GMRES::   estimated residual at iteration 8: 0.339229
+DEAL:GMRES::   estimated residual at iteration 9: 0.260767
+DEAL:GMRES::   estimated residual at iteration 10: 0.189115
+DEAL:GMRES::   estimated residual at iteration 11: 0.126467
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 13: 0.0505275
+DEAL:GMRES::   estimated residual at iteration 14: 0.0360998
+DEAL:GMRES::   estimated residual at iteration 15: 0.0253697
+DEAL:GMRES::   estimated residual at iteration 16: 0.0184200
+DEAL:GMRES::   estimated residual at iteration 17: 0.0142333
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 19: 0.00989870
+DEAL:GMRES::   estimated residual at iteration 20: 0.00800703
+DEAL:GMRES::   estimated residual at iteration 21: 0.00604107
+DEAL:GMRES::   estimated residual at iteration 22: 0.00431736
+DEAL:GMRES::   estimated residual at iteration 23: 0.00304828
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 25: 0.00141669
+DEAL:GMRES::   estimated residual at iteration 26: 0.00101755
+DEAL:GMRES::   estimated residual at iteration 27: 0.000724887
+DEAL:GMRES::   estimated residual at iteration 28: 0.000535249
+DEAL:GMRES::   estimated residual at iteration 29: 0.000423665
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 31: 0.000307521
+DEAL:GMRES::   estimated residual at iteration 32: 0.000247031
+DEAL:GMRES::   estimated residual at iteration 33: 0.000183614
+DEAL:GMRES::   estimated residual at iteration 34: 0.000129847
+DEAL:GMRES::Convergence step 35 value 9.20930e-05
+DEAL:GMRES::   estimated residual at iteration 35: 9.20930e-05
+DEAL::True residual: 9.20930e-05
+DEAL::Solve with diagonal preconditioner: 
+DEAL:GMRES::Starting value 5.47723
+DEAL:GMRES::   estimated residual at iteration 0: 5.47723
+DEAL:GMRES::   estimated residual at iteration 1: 2.67042
+DEAL:GMRES::   estimated residual at iteration 2: 1.70538
+DEAL:GMRES::   estimated residual at iteration 3: 1.20190
+DEAL:GMRES::   estimated residual at iteration 4: 0.884567
+DEAL:GMRES::   estimated residual at iteration 5: 0.662215
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 7: 0.419909
+DEAL:GMRES::   estimated residual at iteration 8: 0.339229
+DEAL:GMRES::   estimated residual at iteration 9: 0.260767
+DEAL:GMRES::   estimated residual at iteration 10: 0.189115
+DEAL:GMRES::   estimated residual at iteration 11: 0.126467
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 13: 0.0505275
+DEAL:GMRES::   estimated residual at iteration 14: 0.0360998
+DEAL:GMRES::   estimated residual at iteration 15: 0.0253697
+DEAL:GMRES::   estimated residual at iteration 16: 0.0184200
+DEAL:GMRES::   estimated residual at iteration 17: 0.0142333
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 19: 0.00989870
+DEAL:GMRES::   estimated residual at iteration 20: 0.00800703
+DEAL:GMRES::   estimated residual at iteration 21: 0.00604107
+DEAL:GMRES::   estimated residual at iteration 22: 0.00431736
+DEAL:GMRES::   estimated residual at iteration 23: 0.00304828
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 25: 0.00141669
+DEAL:GMRES::   estimated residual at iteration 26: 0.00101755
+DEAL:GMRES::   estimated residual at iteration 27: 0.000724887
+DEAL:GMRES::   estimated residual at iteration 28: 0.000535249
+DEAL:GMRES::   estimated residual at iteration 29: 0.000423665
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 31: 0.000307521
+DEAL:GMRES::   estimated residual at iteration 32: 0.000247031
+DEAL:GMRES::   estimated residual at iteration 33: 0.000183614
+DEAL:GMRES::   estimated residual at iteration 34: 0.000129847
+DEAL:GMRES::Convergence step 35 value 9.20930e-05
+DEAL:GMRES::   estimated residual at iteration 35: 9.20930e-05
+DEAL::True residual: 9.20930e-05
+DEAL::Solve with PreconditionIdentity: 
+DEAL:GMRES::Starting value 9.20930e-05
+DEAL:GMRES::Convergence step 0 value 9.20930e-05
+DEAL:GMRES::   estimated residual at iteration 0: 9.20930e-05
+DEAL::True residual: 9.20930e-05
+DEAL::Solve with diagonal preconditioner: 
+DEAL:GMRES::Starting value 5.47723
+DEAL:GMRES::   estimated residual at iteration 0: 5.47723
+DEAL:GMRES::   estimated residual at iteration 1: 2.67042
+DEAL:GMRES::   estimated residual at iteration 2: 1.70538
+DEAL:GMRES::   estimated residual at iteration 3: 1.20190
+DEAL:GMRES::   estimated residual at iteration 4: 0.884567
+DEAL:GMRES::   estimated residual at iteration 5: 0.662215
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 7: 0.419909
+DEAL:GMRES::   estimated residual at iteration 8: 0.339229
+DEAL:GMRES::   estimated residual at iteration 9: 0.260767
+DEAL:GMRES::   estimated residual at iteration 10: 0.189115
+DEAL:GMRES::   estimated residual at iteration 11: 0.126467
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 13: 0.0505275
+DEAL:GMRES::   estimated residual at iteration 14: 0.0360998
+DEAL:GMRES::   estimated residual at iteration 15: 0.0253697
+DEAL:GMRES::   estimated residual at iteration 16: 0.0184200
+DEAL:GMRES::   estimated residual at iteration 17: 0.0142333
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 19: 0.00989870
+DEAL:GMRES::   estimated residual at iteration 20: 0.00800703
+DEAL:GMRES::   estimated residual at iteration 21: 0.00604107
+DEAL:GMRES::   estimated residual at iteration 22: 0.00431736
+DEAL:GMRES::   estimated residual at iteration 23: 0.00304828
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 25: 0.00141669
+DEAL:GMRES::   estimated residual at iteration 26: 0.00101755
+DEAL:GMRES::   estimated residual at iteration 27: 0.000724887
+DEAL:GMRES::   estimated residual at iteration 28: 0.000535249
+DEAL:GMRES::   estimated residual at iteration 29: 0.000423665
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 31: 0.000307521
+DEAL:GMRES::   estimated residual at iteration 32: 0.000247031
+DEAL:GMRES::   estimated residual at iteration 33: 0.000183614
+DEAL:GMRES::   estimated residual at iteration 34: 0.000129847
+DEAL:GMRES::Convergence step 35 value 9.20930e-05
+DEAL:GMRES::   estimated residual at iteration 35: 9.20930e-05
+DEAL::True residual: 9.20930e-05
diff --git a/tests/lac/solver_gmres_04.cc b/tests/lac/solver_gmres_04.cc
new file mode 100644 (file)
index 0000000..c95aa25
--- /dev/null
@@ -0,0 +1,151 @@
+// ------------------------------------------------------------------------
+//
+// SPDX-License-Identifier: LGPL-2.1-or-later
+// Copyright (C) 2022 - 2023 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// Part of the source code is dual licensed under Apache-2.0 WITH
+// LLVM-exception OR LGPL-2.1-or-later. Detailed license information
+// governing the source code and code contributions can be found in
+// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
+//
+// ------------------------------------------------------------------------
+
+// Check the path of SolverGMRES with distributed vectors and
+// LinearAlgebra::OrthogonalizationStrategy::delayed_classical_gram_schmidt
+// and dealii::Vector classes.
+
+
+#include <deal.II/lac/block_vector.h>
+#include <deal.II/lac/diagonal_matrix.h>
+#include <deal.II/lac/precondition.h>
+#include <deal.II/lac/solver_gmres.h>
+#include <deal.II/lac/vector.h>
+
+#include "../tests.h"
+
+
+struct MyDiagonalMatrix
+{
+  MyDiagonalMatrix(const Vector<double> &diagonal)
+    : diagonal(diagonal)
+  {}
+
+  void
+  vmult(Vector<double> &dst, const Vector<double> &src) const
+  {
+    dst = src;
+    dst.scale(diagonal);
+  }
+
+  void
+  vmult(BlockVector<double> &dst, const BlockVector<double> &src) const
+  {
+    dst = src;
+    for (unsigned int b = 0; b < src.n_blocks(); ++b)
+      dst.block(0).scale(diagonal);
+  }
+
+  unsigned int
+  m() const
+  {
+    return diagonal.size();
+  }
+
+  const Vector<double> &diagonal;
+};
+
+
+
+SolverControl::State
+monitor_norm(const unsigned int iteration,
+             const double       check_value,
+             const Vector<double> &)
+{
+  deallog << "   estimated residual at iteration " << iteration << ": "
+          << check_value << std::endl;
+  return SolverControl::success;
+}
+
+
+
+SolverControl::State
+monitor_norm_block(const unsigned int iteration,
+                   const double       check_value,
+                   const BlockVector<double> &)
+{
+  deallog << "   estimated residual at iteration " << iteration << ": "
+          << check_value << std::endl;
+  return SolverControl::success;
+}
+
+
+int
+main()
+{
+  initlog();
+
+  // Create diagonal matrix with entries between 1 and 30
+  Vector<double> matrix_entries_(30);
+  matrix_entries_ = 1.0;
+  MyDiagonalMatrix unit_matrix(matrix_entries_);
+
+  Vector<double> matrix_entries(unit_matrix.m());
+  for (unsigned int i = 0; i < unit_matrix.m(); ++i)
+    matrix_entries(i) = i + 1;
+  MyDiagonalMatrix matrix(matrix_entries);
+
+  Vector<double> rhs(unit_matrix.m());
+  Vector<double> sol(unit_matrix.m());
+  rhs = 1.;
+
+  {
+    deallog << "Solve with PreconditionIdentity: " << std::endl;
+    SolverControl                               control(40, 1e-4);
+    SolverGMRES<Vector<double>>::AdditionalData data3(6);
+    data3.orthogonalization_strategy =
+      LinearAlgebra::OrthogonalizationStrategy::delayed_classical_gram_schmidt;
+    SolverGMRES<Vector<double>> solver(control, data3);
+    solver.connect(&monitor_norm);
+    solver.solve(matrix, sol, rhs, PreconditionIdentity());
+    Vector<double> vec(sol);
+    matrix.vmult(vec, sol);
+    vec -= rhs;
+    deallog << "True residual: " << vec.l2_norm() << std::endl;
+
+    deallog << "Solve with diagonal preconditioner: " << std::endl;
+    sol = 0;
+    solver.solve(matrix, sol, rhs, unit_matrix);
+    matrix.vmult(vec, sol);
+    vec -= rhs;
+    deallog << "True residual: " << vec.l2_norm() << std::endl;
+  }
+
+  {
+    BlockVector<double> rhs_(1);
+    BlockVector<double> sol_(1);
+    rhs_.block(0) = rhs;
+    sol_.block(0) = sol;
+
+    deallog << "Solve with PreconditionIdentity: " << std::endl;
+    SolverControl                                    control(40, 1e-4);
+    SolverGMRES<BlockVector<double>>::AdditionalData data3(6);
+    data3.orthogonalization_strategy =
+      LinearAlgebra::OrthogonalizationStrategy::delayed_classical_gram_schmidt;
+    SolverGMRES<BlockVector<double>> solver(control, data3);
+    solver.connect(&monitor_norm_block);
+    solver.solve(matrix, sol_, rhs_, PreconditionIdentity());
+    BlockVector<double> vec(sol_);
+    matrix.vmult(vec, sol_);
+    vec -= rhs_;
+    deallog << "True residual: " << vec.l2_norm() << std::endl;
+
+    deallog << "Solve with diagonal preconditioner: " << std::endl;
+    sol_ = 0;
+    solver.solve(matrix, sol_, rhs_, unit_matrix);
+    matrix.vmult(vec, sol_);
+    vec -= rhs_;
+    deallog << "True residual: " << vec.l2_norm() << std::endl;
+  }
+}
diff --git a/tests/lac/solver_gmres_04.output b/tests/lac/solver_gmres_04.output
new file mode 100644 (file)
index 0000000..9b16c8a
--- /dev/null
@@ -0,0 +1,141 @@
+
+DEAL::Solve with PreconditionIdentity: 
+DEAL:GMRES::Starting value 5.47723
+DEAL:GMRES::   estimated residual at iteration 0: 5.47723
+DEAL:GMRES::   estimated residual at iteration 1: 2.67042
+DEAL:GMRES::   estimated residual at iteration 2: 1.70538
+DEAL:GMRES::   estimated residual at iteration 3: 1.20190
+DEAL:GMRES::   estimated residual at iteration 4: 0.884567
+DEAL:GMRES::   estimated residual at iteration 5: 0.662215
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 7: 0.419909
+DEAL:GMRES::   estimated residual at iteration 8: 0.339229
+DEAL:GMRES::   estimated residual at iteration 9: 0.260767
+DEAL:GMRES::   estimated residual at iteration 10: 0.189115
+DEAL:GMRES::   estimated residual at iteration 11: 0.126467
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 13: 0.0505275
+DEAL:GMRES::   estimated residual at iteration 14: 0.0360998
+DEAL:GMRES::   estimated residual at iteration 15: 0.0253697
+DEAL:GMRES::   estimated residual at iteration 16: 0.0184200
+DEAL:GMRES::   estimated residual at iteration 17: 0.0142333
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 19: 0.00989870
+DEAL:GMRES::   estimated residual at iteration 20: 0.00800703
+DEAL:GMRES::   estimated residual at iteration 21: 0.00604107
+DEAL:GMRES::   estimated residual at iteration 22: 0.00431736
+DEAL:GMRES::   estimated residual at iteration 23: 0.00304828
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 25: 0.00141669
+DEAL:GMRES::   estimated residual at iteration 26: 0.00101755
+DEAL:GMRES::   estimated residual at iteration 27: 0.000724887
+DEAL:GMRES::   estimated residual at iteration 28: 0.000535249
+DEAL:GMRES::   estimated residual at iteration 29: 0.000423665
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 31: 0.000307521
+DEAL:GMRES::   estimated residual at iteration 32: 0.000247031
+DEAL:GMRES::   estimated residual at iteration 33: 0.000183614
+DEAL:GMRES::   estimated residual at iteration 34: 0.000129847
+DEAL:GMRES::Convergence step 35 value 9.20930e-05
+DEAL:GMRES::   estimated residual at iteration 35: 9.20930e-05
+DEAL::True residual: 9.20930e-05
+DEAL::Solve with diagonal preconditioner: 
+DEAL:GMRES::Starting value 5.47723
+DEAL:GMRES::   estimated residual at iteration 0: 5.47723
+DEAL:GMRES::   estimated residual at iteration 1: 2.67042
+DEAL:GMRES::   estimated residual at iteration 2: 1.70538
+DEAL:GMRES::   estimated residual at iteration 3: 1.20190
+DEAL:GMRES::   estimated residual at iteration 4: 0.884567
+DEAL:GMRES::   estimated residual at iteration 5: 0.662215
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 7: 0.419909
+DEAL:GMRES::   estimated residual at iteration 8: 0.339229
+DEAL:GMRES::   estimated residual at iteration 9: 0.260767
+DEAL:GMRES::   estimated residual at iteration 10: 0.189115
+DEAL:GMRES::   estimated residual at iteration 11: 0.126467
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 13: 0.0505275
+DEAL:GMRES::   estimated residual at iteration 14: 0.0360998
+DEAL:GMRES::   estimated residual at iteration 15: 0.0253697
+DEAL:GMRES::   estimated residual at iteration 16: 0.0184200
+DEAL:GMRES::   estimated residual at iteration 17: 0.0142333
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 19: 0.00989870
+DEAL:GMRES::   estimated residual at iteration 20: 0.00800703
+DEAL:GMRES::   estimated residual at iteration 21: 0.00604107
+DEAL:GMRES::   estimated residual at iteration 22: 0.00431736
+DEAL:GMRES::   estimated residual at iteration 23: 0.00304828
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 25: 0.00141669
+DEAL:GMRES::   estimated residual at iteration 26: 0.00101755
+DEAL:GMRES::   estimated residual at iteration 27: 0.000724887
+DEAL:GMRES::   estimated residual at iteration 28: 0.000535249
+DEAL:GMRES::   estimated residual at iteration 29: 0.000423665
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 31: 0.000307521
+DEAL:GMRES::   estimated residual at iteration 32: 0.000247031
+DEAL:GMRES::   estimated residual at iteration 33: 0.000183614
+DEAL:GMRES::   estimated residual at iteration 34: 0.000129847
+DEAL:GMRES::Convergence step 35 value 9.20930e-05
+DEAL:GMRES::   estimated residual at iteration 35: 9.20930e-05
+DEAL::True residual: 9.20930e-05
+DEAL::Solve with PreconditionIdentity: 
+DEAL:GMRES::Starting value 9.20930e-05
+DEAL:GMRES::Convergence step 0 value 9.20930e-05
+DEAL:GMRES::   estimated residual at iteration 0: 9.20930e-05
+DEAL::True residual: 9.20930e-05
+DEAL::Solve with diagonal preconditioner: 
+DEAL:GMRES::Starting value 5.47723
+DEAL:GMRES::   estimated residual at iteration 0: 5.47723
+DEAL:GMRES::   estimated residual at iteration 1: 2.67042
+DEAL:GMRES::   estimated residual at iteration 2: 1.70538
+DEAL:GMRES::   estimated residual at iteration 3: 1.20190
+DEAL:GMRES::   estimated residual at iteration 4: 0.884567
+DEAL:GMRES::   estimated residual at iteration 5: 0.662215
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 6: 0.496462
+DEAL:GMRES::   estimated residual at iteration 7: 0.419909
+DEAL:GMRES::   estimated residual at iteration 8: 0.339229
+DEAL:GMRES::   estimated residual at iteration 9: 0.260767
+DEAL:GMRES::   estimated residual at iteration 10: 0.189115
+DEAL:GMRES::   estimated residual at iteration 11: 0.126467
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 12: 0.0736025
+DEAL:GMRES::   estimated residual at iteration 13: 0.0505275
+DEAL:GMRES::   estimated residual at iteration 14: 0.0360998
+DEAL:GMRES::   estimated residual at iteration 15: 0.0253697
+DEAL:GMRES::   estimated residual at iteration 16: 0.0184200
+DEAL:GMRES::   estimated residual at iteration 17: 0.0142333
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 18: 0.0116662
+DEAL:GMRES::   estimated residual at iteration 19: 0.00989870
+DEAL:GMRES::   estimated residual at iteration 20: 0.00800703
+DEAL:GMRES::   estimated residual at iteration 21: 0.00604107
+DEAL:GMRES::   estimated residual at iteration 22: 0.00431736
+DEAL:GMRES::   estimated residual at iteration 23: 0.00304828
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 24: 0.00203679
+DEAL:GMRES::   estimated residual at iteration 25: 0.00141669
+DEAL:GMRES::   estimated residual at iteration 26: 0.00101755
+DEAL:GMRES::   estimated residual at iteration 27: 0.000724887
+DEAL:GMRES::   estimated residual at iteration 28: 0.000535249
+DEAL:GMRES::   estimated residual at iteration 29: 0.000423665
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 30: 0.000358414
+DEAL:GMRES::   estimated residual at iteration 31: 0.000307521
+DEAL:GMRES::   estimated residual at iteration 32: 0.000247031
+DEAL:GMRES::   estimated residual at iteration 33: 0.000183614
+DEAL:GMRES::   estimated residual at iteration 34: 0.000129847
+DEAL:GMRES::Convergence step 35 value 9.20930e-05
+DEAL:GMRES::   estimated residual at iteration 35: 9.20930e-05
+DEAL::True residual: 9.20930e-05

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.