From: Timo Heister Date: Sun, 14 Aug 2016 23:33:54 +0000 (-0400) Subject: remove duplicate tests X-Git-Tag: v8.5.0-rc1~773^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F2956%2Fhead;p=dealii.git remove duplicate tests --- diff --git a/tests/bits/sparsity_pattern_01_x.cc b/tests/bits/sparsity_pattern_01_x.cc deleted file mode 100644 index 6749a8a274..0000000000 --- a/tests/bits/sparsity_pattern_01_x.cc +++ /dev/null @@ -1,54 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2004 - 2015 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 at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check SparsityPattern::copy_from(DynamicSparsityPattern) - -#include "../tests.h" -#include -#include -#include -#include -#include - - -void test () -{ - const unsigned int N = 100; - DynamicSparsityPattern csp (N,N); - for (unsigned int i=0; i -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include - -#include - - - -bool operator == (const BlockSparsityPattern &sp1, - const BlockSparsityPattern &sp2) -{ - if (sp1.n_block_rows() != sp2.n_block_rows()) - return false; - - if (sp1.n_block_cols() != sp2.n_block_cols()) - return false; - - for (unsigned int i=0; i -void -check () -{ - Triangulation tr; - if (dim==2) - GridGenerator::hyper_ball(tr, Point(), 1); - else - GridGenerator::hyper_cube(tr, -1,1); - tr.refine_global (1); - tr.begin_active()->set_refine_flag (); - tr.execute_coarsening_and_refinement (); - tr.begin_active(2)->set_refine_flag (); - tr.execute_coarsening_and_refinement (); - if (dim==1) - tr.refine_global(2); - - // create a system element composed - // of one Q1 and one Q2 element - FESystem element(FE_Q(1), 1, - FE_Q(2), 1); - DoFHandler dof(tr); - dof.distribute_dofs(element); - - ConstraintMatrix constraints; - DoFTools::make_hanging_node_constraints (dof, constraints); - constraints.close (); - - -//--------------- Regular sparsity pattern checks ----------------- - - // first way: directly - SparsityPattern sparsity_1 (dof.n_dofs(), dof.n_dofs()); - DoFTools::make_sparsity_pattern (dof, sparsity_1); - constraints.condense (sparsity_1); - sparsity_1.compress (); - - // second way: via direct elimination of - // constraints - SparsityPattern sparsity_2; - DynamicSparsityPattern csp_2 (dof.n_dofs()); - DoFTools::make_sparsity_pattern (dof, csp_2, constraints); - sparsity_2.copy_from (csp_2); - - - // the exact content of sparsity - // patterns is checked in other - // tests, so only make sure that - // sparsity_[12] are equal - deallog << "Check 1:" - << " -- " - << (sparsity_1 == sparsity_2 ? "ok" : "failed") - << std::endl; - - - -//--------------- Block sparsity pattern checks ----------------- - - const unsigned int n = dof.n_dofs(); - const unsigned int n1 = n/3; - const unsigned int n2 = n - n1; - - BlockSparsityPattern sparsity_3(2,2); - sparsity_3.block(0,0).reinit (n1,n1,n); - sparsity_3.block(1,0).reinit (n2,n1,n); - sparsity_3.block(0,1).reinit (n1,n2,n); - sparsity_3.block(1,1).reinit (n2,n2,n); - sparsity_3.collect_sizes (); - - DoFTools::make_sparsity_pattern (dof, sparsity_3); - constraints.condense (sparsity_3); - sparsity_3.compress (); - - BlockSparsityPattern sparsity_4; - BlockDynamicSparsityPattern csp_4(2,2); - csp_4.block(0,0).reinit (n1,n1); - csp_4.block(1,0).reinit (n2,n1); - csp_4.block(0,1).reinit (n1,n2); - csp_4.block(1,1).reinit (n2,n2); - csp_4.collect_sizes (); - - DoFTools::make_sparsity_pattern (dof, csp_4, constraints); - csp_4.compress (); - - sparsity_4.copy_from (csp_4); - - deallog << "Check 2:" - << " -- " - << (sparsity_3 == sparsity_4 ? "ok" : "failed") - << std::endl; -} - - - -int main () -{ - std::ofstream logfile ("output"); - deallog << std::setprecision (2); - deallog << std::fixed; - deallog.attach(logfile); - - deallog.push ("1d"); - check<1> (); - deallog.pop (); - deallog.push ("2d"); - check<2> (); - deallog.pop (); - deallog.push ("3d"); - check<3> (); - deallog.pop (); -} diff --git a/tests/dofs/sparsity_pattern_05_x.output b/tests/dofs/sparsity_pattern_05_x.output deleted file mode 100644 index 73a9c0b38e..0000000000 --- a/tests/dofs/sparsity_pattern_05_x.output +++ /dev/null @@ -1,7 +0,0 @@ - -DEAL:1d::Check 1: -- ok -DEAL:1d::Check 2: -- ok -DEAL:2d::Check 1: -- ok -DEAL:2d::Check 2: -- ok -DEAL:3d::Check 1: -- ok -DEAL:3d::Check 2: -- ok diff --git a/tests/hp/crash_17_dynamic_sparsity.cc b/tests/hp/crash_17_dynamic_sparsity.cc deleted file mode 100644 index fb2d860f10..0000000000 --- a/tests/hp/crash_17_dynamic_sparsity.cc +++ /dev/null @@ -1,737 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2006 - 2015 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 at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// a modified version of step-27 that crashes because of circular constraints. -// like crash_17, but use a DynamicSparsityPattern instead to test -// that class some more - -char logname[] = "output"; - - -#include "../tests.h" - - -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include - -#include -#include - -#include -#include -#include -#include -#include - -#include - -// Finally, this is as in previous -// programs: -using namespace dealii; - -template -class LaplaceProblem -{ -public: - LaplaceProblem (); - ~LaplaceProblem (); - - void run (); - -private: - void setup_system (); - void assemble_system (); - void solve (); - void create_coarse_grid (); - void refine_grid (); - void estimate_smoothness (Vector &smoothness_indicators) const; - void output_results (const unsigned int cycle) const; - - Triangulation triangulation; - - hp::DoFHandler dof_handler; - hp::FECollection fe_collection; - hp::QCollection quadrature_collection; - hp::QCollection face_quadrature_collection; - - ConstraintMatrix hanging_node_constraints; - - SparsityPattern sparsity_pattern; - SparseMatrix system_matrix; - - Vector solution; - Vector system_rhs; - - Timer distr, condense, hang; -}; - - - -template -class RightHandSide : public Function -{ -public: - RightHandSide () : Function () {} - - virtual double value (const Point &p, - const unsigned int component) const; -}; - - -template -double -RightHandSide::value (const Point &p, - const unsigned int /*component*/) const -{ - double product = 1; - for (unsigned int d=0; d -LaplaceProblem::LaplaceProblem () : - dof_handler (triangulation) -{ - for (unsigned int degree=2; degree<5; ++degree) - { - fe_collection.push_back (FE_Q(QIterated<1>(QTrapez<1>(),degree))); - quadrature_collection.push_back (QGauss(degree+2)); - face_quadrature_collection.push_back (QGauss(degree+2)); - } -} - - -template -LaplaceProblem::~LaplaceProblem () -{ - dof_handler.clear (); -} - -template -void LaplaceProblem::setup_system () -{ - distr.reset(); - distr.start(); - dof_handler.distribute_dofs (fe_collection); - distr.stop(); - - solution.reinit (dof_handler.n_dofs()); - system_rhs.reinit (dof_handler.n_dofs()); - - hanging_node_constraints.clear (); - hang.reset(); - hang.start(); - DoFTools::make_hanging_node_constraints (dof_handler, - hanging_node_constraints); - hanging_node_constraints.write_dot (deallog.get_file_stream()); - hanging_node_constraints.close (); - hang.stop(); - - if (dim < 3) - { - sparsity_pattern.reinit (dof_handler.n_dofs(), - dof_handler.n_dofs(), - dof_handler.max_couplings_between_dofs()); - DoFTools::make_sparsity_pattern (dof_handler, sparsity_pattern); - - condense.reset(); - condense.start(); - hanging_node_constraints.condense (sparsity_pattern); - condense.stop(); - sparsity_pattern.compress(); - } - else - { - DynamicSparsityPattern csp (dof_handler.n_dofs(), - dof_handler.n_dofs()); - DoFTools::make_sparsity_pattern (dof_handler, csp); - - condense.reset(); - condense.start(); - hanging_node_constraints.condense (csp); - condense.stop(); - - sparsity_pattern.copy_from (csp); - } - - system_matrix.reinit (sparsity_pattern); -} - -template -void LaplaceProblem::assemble_system () -{ - hp::FEValues hp_fe_values (fe_collection, - quadrature_collection, - update_values | update_gradients | - update_q_points | update_JxW_values); - - const RightHandSide rhs_function; - - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (; cell!=endc; ++cell) - { - const unsigned int dofs_per_cell = cell->get_fe().dofs_per_cell; - FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - Vector cell_rhs (dofs_per_cell); - - std::vector local_dof_indices (dofs_per_cell); - - cell_matrix = 0; - cell_rhs = 0; - - hp_fe_values.reinit (cell); - - const FEValues &fe_values = hp_fe_values.get_present_fe_values (); - - std::vector rhs_values (fe_values.n_quadrature_points); - rhs_function.value_list (fe_values.get_quadrature_points(), - rhs_values); - - for (unsigned int q_point=0; q_pointget_dof_indices (local_dof_indices); - for (unsigned int i=0; i boundary_values; - VectorTools::interpolate_boundary_values (dof_handler, - 0, - ZeroFunction(), - boundary_values); - MatrixTools::apply_boundary_values (boundary_values, - system_matrix, - solution, - system_rhs); -} - -template -void LaplaceProblem::solve () -{ - SolverControl solver_control (system_rhs.size(), - 1e-8*system_rhs.l2_norm()); - SolverCG<> cg (solver_control); - - PreconditionSSOR<> preconditioner; - preconditioner.initialize(system_matrix, 1.2); - - cg.solve (system_matrix, solution, system_rhs, - preconditioner); - - hanging_node_constraints.distribute (solution); -} - - -unsigned int -int_pow (const unsigned int x, - const unsigned int n) -{ - unsigned int p=1; - for (unsigned int i=0; i -void -LaplaceProblem:: -estimate_smoothness (Vector &smoothness_indicators) const -{ - const unsigned int N = 4; - - // form all the Fourier vectors - // that we want to - // consider. exclude k=0 to avoid - // problems with |k|^{-mu} and also - // logarithms of |k| - std::vector > k_vectors; - std::vector k_vectors_magnitude; - switch (dim) - { - case 2: - { - for (unsigned int i=0; i(numbers::PI * i, - numbers::PI * j)); - k_vectors_magnitude.push_back (i*i+j*j); - } - - break; - } - - case 3: - { - for (unsigned int i=0; i(numbers::PI * i, - numbers::PI * j, - numbers::PI * k)); - k_vectors_magnitude.push_back (i*i+j*j+k*k); - } - - break; - } - - default: - Assert (false, ExcNotImplemented()); - } - - const unsigned n_fourier_modes = k_vectors.size(); - std::vector ln_k (n_fourier_modes); - for (unsigned int i=0; i base_quadrature (2); - QIterated quadrature (base_quadrature, N); - - std::vector > > - fourier_transform_matrices (fe_collection.size()); - for (unsigned int fe=0; fe sum = 0; - for (unsigned int q=0; q x_q = quadrature.point(q); - sum += std::exp(std::complex(0,1) * - (k_vectors[k] * x_q)) * - fe_collection[fe].shape_value(i,x_q) * - quadrature.weight(q); - } - fourier_transform_matrices[fe](k,i) - = sum / std::pow(2*numbers::PI, 1.*dim/2); - } - } - - // the next thing is to loop over - // all cells and do our work there, - // i.e. to locally do the Fourier - // transform and estimate the decay - // coefficient - std::vector > fourier_coefficients (n_fourier_modes); - Vector local_dof_values; - - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (unsigned int index=0; cell!=endc; ++cell, ++index) - { - local_dof_values.reinit (cell->get_fe().dofs_per_cell); - cell->get_dof_values (solution, local_dof_values); - - // first compute the Fourier - // transform of the local - // solution - std::fill (fourier_coefficients.begin(), fourier_coefficients.end(), 0); - for (unsigned int f=0; fget_fe().dofs_per_cell; ++i) - fourier_coefficients[f] += - fourier_transform_matrices[cell->active_fe_index()](f,i) - * - local_dof_values(i); - - // enter the Fourier - // coefficients into a map with - // the k-magnitudes, to make - // sure that we get only the - // largest magnitude for each - // value of |k| - std::map k_to_max_U_map; - for (unsigned int f=0; f -void LaplaceProblem::refine_grid () -{ - Vector estimated_error_per_cell (triangulation.n_active_cells()); - KellyErrorEstimator::estimate (dof_handler, - face_quadrature_collection, - typename FunctionMap::type(), - solution, - estimated_error_per_cell); - - Vector smoothness_indicators (triangulation.n_active_cells()); - estimate_smoothness (smoothness_indicators); - - GridRefinement::refine_and_coarsen_fixed_number (triangulation, - estimated_error_per_cell, - 0.3, 0.03); - - float max_smoothness = 0, - min_smoothness = smoothness_indicators.linfty_norm(); - { - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (unsigned int index=0; cell!=endc; ++cell, ++index) - if (cell->refine_flag_set()) - { - max_smoothness = std::max (max_smoothness, - smoothness_indicators(index)); - min_smoothness = std::min (min_smoothness, - smoothness_indicators(index)); - } - } - const float cutoff_smoothness = (max_smoothness + min_smoothness) / 2; - { - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (unsigned int index=0; cell!=endc; ++cell, ++index) - if (cell->refine_flag_set() - && - (smoothness_indicators(index) > cutoff_smoothness) - && - !(cell->active_fe_index() == fe_collection.size() - 1)) - { - cell->clear_refine_flag(); - cell->set_active_fe_index (std::min (cell->active_fe_index() + 1, - fe_collection.size() - 1)); - } - } - - triangulation.execute_coarsening_and_refinement (); -} - - - -template -void LaplaceProblem::output_results (const unsigned int cycle) const -{ - Assert (cycle < 10, ExcNotImplemented()); - - { - const std::string filename = "grid-" + - Utilities::int_to_string (cycle, 2) + - ".eps"; - std::ofstream output (filename.c_str()); - - GridOut grid_out; - grid_out.write_eps (triangulation, output); - } - - { - Vector smoothness_indicators (triangulation.n_active_cells()); - estimate_smoothness (smoothness_indicators); - - Vector smoothness_field (dof_handler.n_dofs()); - DoFTools::distribute_cell_to_dof_vector (dof_handler, - smoothness_indicators, - smoothness_field); - - Vector fe_indices (triangulation.n_active_cells()); - { - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (unsigned int index=0; cell!=endc; ++cell, ++index) - { - - fe_indices(index) = cell->active_fe_index(); -// smoothness_indicators(index) *= std::sqrt(cell->diameter()); - } - } - - const std::string filename = "solution-" + - Utilities::int_to_string (cycle, 2) + - ".vtk"; - DataOut > data_out; - - data_out.attach_dof_handler (dof_handler); - data_out.add_data_vector (solution, "solution"); - data_out.add_data_vector (smoothness_indicators, "smoothness1"); - data_out.add_data_vector (smoothness_field, "smoothness2"); - data_out.add_data_vector (fe_indices, "fe_index"); - data_out.build_patches (); - - std::ofstream output (filename.c_str()); - data_out.write_vtk (output); - } -} - - -template <> -void LaplaceProblem<2>::create_coarse_grid () -{ - const unsigned int dim = 2; - - static const Point<2> vertices_1[] - = { Point<2> (-1., -1.), - Point<2> (-1./2, -1.), - Point<2> (0., -1.), - Point<2> (+1./2, -1.), - Point<2> (+1, -1.), - - Point<2> (-1., -1./2.), - Point<2> (-1./2, -1./2.), - Point<2> (0., -1./2.), - Point<2> (+1./2, -1./2.), - Point<2> (+1, -1./2.), - - Point<2> (-1., 0.), - Point<2> (-1./2, 0.), - Point<2> (+1./2, 0.), - Point<2> (+1, 0.), - - Point<2> (-1., 1./2.), - Point<2> (-1./2, 1./2.), - Point<2> (0., 1./2.), - Point<2> (+1./2, 1./2.), - Point<2> (+1, 1./2.), - - Point<2> (-1., 1.), - Point<2> (-1./2, 1.), - Point<2> (0., 1.), - Point<2> (+1./2, 1.), - Point<2> (+1, 1.) - }; - const unsigned int - n_vertices = sizeof(vertices_1) / sizeof(vertices_1[0]); - const std::vector > vertices (&vertices_1[0], - &vertices_1[n_vertices]); - static const int cell_vertices[][GeometryInfo::vertices_per_cell] - = {{0, 1, 5, 6}, - {1, 2, 6, 7}, - {2, 3, 7, 8}, - {3, 4, 8, 9}, - {5, 6, 10, 11}, - {8, 9, 12, 13}, - {10, 11, 14, 15}, - {12, 13, 17, 18}, - {14, 15, 19, 20}, - {15, 16, 20, 21}, - {16, 17, 21, 22}, - {17, 18, 22, 23} - }; - const unsigned int - n_cells = sizeof(cell_vertices) / sizeof(cell_vertices[0]); - - std::vector > cells (n_cells, CellData()); - for (unsigned int i=0; i::vertices_per_cell; - ++j) - cells[i].vertices[j] = cell_vertices[i][j]; - cells[i].material_id = 0; - } - - triangulation.create_triangulation (vertices, - cells, - SubCellData()); - triangulation.refine_global (3); -} - - - -template <> -void LaplaceProblem<3>::create_coarse_grid () -{ - GridGenerator::hyper_cube (triangulation); - triangulation.refine_global (1); -} - - - -template -void LaplaceProblem::run () -{ - for (unsigned int cycle=0; cycle<4; ++cycle) - { - deallog << "Cycle " << cycle << ':' << std::endl; - - if (cycle == 0) - create_coarse_grid (); - else - refine_grid (); - - - deallog << " Number of active cells: " - << triangulation.n_active_cells() - << std::endl; - - Timer all; - all.start(); - setup_system (); - - deallog << " Number of degrees of freedom: " - << dof_handler.n_dofs() - << std::endl; - deallog << " Number of constraints : " - << hanging_node_constraints.n_constraints() - << std::endl; - - assemble_system (); - solve (); - all.stop(); - - } -} - -int main () -{ - std::ofstream logfile(logname); - logfile.precision (4); - deallog << std::setprecision(4); - - deallog.attach(logfile); - deallog.threshold_double(1.e-10); - try - { - LaplaceProblem<3> laplace_problem_2d; - laplace_problem_2d.run (); - } - catch (std::exception &exc) - { - std::cerr << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - std::cerr << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - - return 1; - } - catch (...) - { - std::cerr << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - std::cerr << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - } - - return 0; -} diff --git a/tests/hp/crash_17_dynamic_sparsity.output b/tests/hp/crash_17_dynamic_sparsity.output deleted file mode 100644 index f2395ead12..0000000000 --- a/tests/hp/crash_17_dynamic_sparsity.output +++ /dev/null @@ -1,5344 +0,0 @@ - -DEAL::Cycle 0: -DEAL:: Number of active cells: 8 -digraph constraints { -} -DEAL:: Number of degrees of freedom: 125 -DEAL:: Number of constraints : 0 -DEAL:cg::Starting value 0.4376 -DEAL:cg::Convergence step 6 value 2.574e-09 -DEAL::Cycle 1: -DEAL:: Number of active cells: 22 -digraph constraints { - 150->35; // weight: 1.000 - 151->13; // weight: 1.000 - 152->43; // weight: 1.000 - 157->5; // weight: 0.3750 - 157->7; // weight: -0.1250 - 157->13; // weight: 0.7500 - 158->35; // weight: 0.3750 - 158->36; // weight: -0.1250 - 158->43; // weight: 0.7500 - 159->5; // weight: 0.3750 - 159->29; // weight: -0.1250 - 159->35; // weight: 0.7500 - 160->13; // weight: 0.3750 - 160->34; // weight: -0.1250 - 160->43; // weight: 0.7500 - 173->5; // weight: 0.1406 - 173->29; // weight: -0.04688 - 173->7; // weight: -0.04688 - 173->30; // weight: 0.01562 - 173->13; // weight: 0.2812 - 173->34; // weight: -0.09375 - 173->35; // weight: 0.2812 - 173->36; // weight: -0.09375 - 173->43; // weight: 0.5625 - 176->34; // weight: 1.000 - 179->29; // weight: 0.3750 - 179->30; // weight: -0.1250 - 179->34; // weight: 0.7500 - 180->5; // weight: -0.1250 - 180->29; // weight: 0.3750 - 180->35; // weight: 0.7500 - 181->13; // weight: -0.1250 - 181->34; // weight: 0.3750 - 181->43; // weight: 0.7500 - 190->5; // weight: -0.04688 - 190->29; // weight: 0.1406 - 190->7; // weight: 0.01562 - 190->30; // weight: -0.04688 - 190->13; // weight: -0.09375 - 190->34; // weight: 0.2812 - 190->35; // weight: 0.2812 - 190->36; // weight: -0.09375 - 190->43; // weight: 0.5625 - 193->36; // weight: 1.000 - 196->5; // weight: -0.1250 - 196->7; // weight: 0.3750 - 196->13; // weight: 0.7500 - 197->35; // weight: -0.1250 - 197->36; // weight: 0.3750 - 197->43; // weight: 0.7500 - 198->7; // weight: 0.3750 - 198->30; // weight: -0.1250 - 198->36; // weight: 0.7500 - 207->5; // weight: -0.04688 - 207->29; // weight: 0.01562 - 207->7; // weight: 0.1406 - 207->30; // weight: -0.04688 - 207->13; // weight: 0.2812 - 207->34; // weight: -0.09375 - 207->35; // weight: -0.09375 - 207->36; // weight: 0.2812 - 207->43; // weight: 0.5625 - 211->29; // weight: -0.1250 - 211->30; // weight: 0.3750 - 211->34; // weight: 0.7500 - 212->7; // weight: -0.1250 - 212->30; // weight: 0.3750 - 212->36; // weight: 0.7500 - 218->5; // weight: 0.01562 - 218->29; // weight: -0.04688 - 218->7; // weight: -0.04688 - 218->30; // weight: 0.1406 - 218->13; // weight: -0.09375 - 218->34; // weight: 0.2812 - 218->35; // weight: -0.09375 - 218->36; // weight: 0.2812 - 218->43; // weight: 0.5625 - 269->15; // weight: 1.000 - 270->52; // weight: 1.000 - 271->61; // weight: 1.000 - 276->6; // weight: 0.3750 - 276->47; // weight: -0.1250 - 276->52; // weight: 0.7500 - 277->15; // weight: 0.3750 - 277->54; // weight: -0.1250 - 277->61; // weight: 0.7500 - 278->6; // weight: 0.3750 - 278->7; // weight: -0.1250 - 278->15; // weight: 0.7500 - 279->52; // weight: 0.3750 - 279->53; // weight: -0.1250 - 279->61; // weight: 0.7500 - 292->6; // weight: 0.1406 - 292->7; // weight: -0.04688 - 292->47; // weight: -0.04688 - 292->48; // weight: 0.01562 - 292->52; // weight: 0.2812 - 292->53; // weight: -0.09375 - 292->15; // weight: 0.2812 - 292->54; // weight: -0.09375 - 292->61; // weight: 0.5625 - 295->53; // weight: 1.000 - 297->7; // weight: 0.3750 - 297->48; // weight: -0.1250 - 297->53; // weight: 0.7500 - 298->6; // weight: -0.1250 - 298->7; // weight: 0.3750 - 298->15; // weight: 0.7500 - 299->52; // weight: -0.1250 - 299->53; // weight: 0.3750 - 299->61; // weight: 0.7500 - 307->6; // weight: -0.04688 - 307->7; // weight: 0.1406 - 307->47; // weight: 0.01562 - 307->48; // weight: -0.04688 - 307->52; // weight: -0.09375 - 307->53; // weight: 0.2812 - 307->15; // weight: 0.2812 - 307->54; // weight: -0.09375 - 307->61; // weight: 0.5625 - 310->54; // weight: 1.000 - 313->6; // weight: -0.1250 - 313->47; // weight: 0.3750 - 313->52; // weight: 0.7500 - 314->15; // weight: -0.1250 - 314->54; // weight: 0.3750 - 314->61; // weight: 0.7500 - 315->47; // weight: 0.3750 - 315->48; // weight: -0.1250 - 315->54; // weight: 0.7500 - 324->6; // weight: -0.04688 - 324->7; // weight: 0.01562 - 324->47; // weight: 0.1406 - 324->48; // weight: -0.04688 - 324->52; // weight: 0.2812 - 324->53; // weight: -0.09375 - 324->15; // weight: -0.09375 - 324->54; // weight: 0.2812 - 324->61; // weight: 0.5625 - 328->7; // weight: -0.1250 - 328->48; // weight: 0.3750 - 328->53; // weight: 0.7500 - 329->47; // weight: -0.1250 - 329->48; // weight: 0.3750 - 329->54; // weight: 0.7500 - 335->6; // weight: 0.01562 - 335->7; // weight: -0.04688 - 335->47; // weight: -0.04688 - 335->48; // weight: 0.1406 - 335->52; // weight: -0.09375 - 335->53; // weight: 0.2812 - 335->15; // weight: -0.09375 - 335->54; // weight: 0.2812 - 335->61; // weight: 0.5625 - 94->7; // weight: 0.2222 - 94->48; // weight: -0.1111 - 94->53; // weight: 0.8889 - 95->7; // weight: -0.1111 - 95->48; // weight: 0.2222 - 95->53; // weight: 0.8889 - 96->30; // weight: 0.2222 - 96->64; // weight: -0.1111 - 96->67; // weight: 0.8889 - 97->30; // weight: -0.1111 - 97->64; // weight: 0.2222 - 97->67; // weight: 0.8889 - 98->7; // weight: 0.2222 - 98->30; // weight: -0.1111 - 98->36; // weight: 0.8889 - 99->7; // weight: -0.1111 - 99->30; // weight: 0.2222 - 99->36; // weight: 0.8889 - 100->48; // weight: 0.2222 - 100->64; // weight: -0.1111 - 100->68; // weight: 0.8889 - 101->48; // weight: -0.1111 - 101->64; // weight: 0.2222 - 101->68; // weight: 0.8889 - 134->7; // weight: 0.04938 - 134->30; // weight: -0.02469 - 134->48; // weight: -0.02469 - 134->64; // weight: 0.01235 - 134->53; // weight: 0.1975 - 134->67; // weight: -0.09877 - 134->36; // weight: 0.1975 - 134->68; // weight: -0.09877 - 134->73; // weight: 0.7901 - 135->7; // weight: -0.02469 - 135->30; // weight: 0.04938 - 135->48; // weight: 0.01235 - 135->64; // weight: -0.02469 - 135->53; // weight: -0.09877 - 135->67; // weight: 0.1975 - 135->36; // weight: 0.1975 - 135->68; // weight: -0.09877 - 135->73; // weight: 0.7901 - 136->7; // weight: -0.02469 - 136->30; // weight: 0.01235 - 136->48; // weight: 0.04938 - 136->64; // weight: -0.02469 - 136->53; // weight: 0.1975 - 136->67; // weight: -0.09877 - 136->36; // weight: -0.09877 - 136->68; // weight: 0.1975 - 136->73; // weight: 0.7901 - 137->7; // weight: 0.01235 - 137->30; // weight: -0.02469 - 137->48; // weight: -0.02469 - 137->64; // weight: 0.04938 - 137->53; // weight: -0.09877 - 137->67; // weight: 0.1975 - 137->36; // weight: -0.09877 - 137->68; // weight: 0.1975 - 137->73; // weight: 0.7901 - 153->84; // weight: 1.000 - 155->88; // weight: 1.000 - 165->5; // weight: 0.3750 - 165->76; // weight: -0.1250 - 165->84; // weight: 0.7500 - 167->13; // weight: 0.3750 - 167->80; // weight: -0.1250 - 167->88; // weight: 0.7500 - 161->84; // weight: 0.3750 - 161->86; // weight: -0.1250 - 161->88; // weight: 0.7500 - 169->5; // weight: 0.1406 - 169->7; // weight: -0.04688 - 169->76; // weight: -0.04688 - 169->78; // weight: 0.01562 - 169->84; // weight: 0.2812 - 169->86; // weight: -0.09375 - 169->13; // weight: 0.2812 - 169->80; // weight: -0.09375 - 169->88; // weight: 0.5625 - 194->86; // weight: 1.000 - 202->7; // weight: 0.3750 - 202->78; // weight: -0.1250 - 202->86; // weight: 0.7500 - 199->84; // weight: -0.1250 - 199->86; // weight: 0.3750 - 199->88; // weight: 0.7500 - 204->5; // weight: -0.04688 - 204->7; // weight: 0.1406 - 204->76; // weight: 0.01562 - 204->78; // weight: -0.04688 - 204->84; // weight: -0.09375 - 204->86; // weight: 0.2812 - 204->13; // weight: 0.2812 - 204->80; // weight: -0.09375 - 204->88; // weight: 0.5625 - 222->80; // weight: 1.000 - 228->5; // weight: -0.1250 - 228->76; // weight: 0.3750 - 228->84; // weight: 0.7500 - 230->13; // weight: -0.1250 - 230->80; // weight: 0.3750 - 230->88; // weight: 0.7500 - 224->76; // weight: 0.3750 - 224->78; // weight: -0.1250 - 224->80; // weight: 0.7500 - 232->5; // weight: -0.04688 - 232->7; // weight: 0.01562 - 232->76; // weight: 0.1406 - 232->78; // weight: -0.04688 - 232->84; // weight: 0.2812 - 232->86; // weight: -0.09375 - 232->13; // weight: -0.09375 - 232->80; // weight: 0.2812 - 232->88; // weight: 0.5625 - 254->7; // weight: -0.1250 - 254->78; // weight: 0.3750 - 254->86; // weight: 0.7500 - 251->76; // weight: -0.1250 - 251->78; // weight: 0.3750 - 251->80; // weight: 0.7500 - 256->5; // weight: 0.01562 - 256->7; // weight: -0.04688 - 256->76; // weight: -0.04688 - 256->78; // weight: 0.1406 - 256->84; // weight: -0.09375 - 256->86; // weight: 0.2812 - 256->13; // weight: -0.09375 - 256->80; // weight: 0.2812 - 256->88; // weight: 0.5625 - 272->85; // weight: 1.000 - 273->90; // weight: 1.000 - 282->85; // weight: 0.3750 - 282->86; // weight: -0.1250 - 282->90; // weight: 0.7500 - 284->6; // weight: 0.3750 - 284->77; // weight: -0.1250 - 284->85; // weight: 0.7500 - 285->15; // weight: 0.3750 - 285->82; // weight: -0.1250 - 285->90; // weight: 0.7500 - 290->6; // weight: 0.1406 - 290->77; // weight: -0.04688 - 290->7; // weight: -0.04688 - 290->78; // weight: 0.01562 - 290->15; // weight: 0.2812 - 290->82; // weight: -0.09375 - 290->85; // weight: 0.2812 - 290->86; // weight: -0.09375 - 290->90; // weight: 0.5625 - 338->82; // weight: 1.000 - 343->77; // weight: 0.3750 - 343->78; // weight: -0.1250 - 343->82; // weight: 0.7500 - 345->6; // weight: -0.1250 - 345->77; // weight: 0.3750 - 345->85; // weight: 0.7500 - 346->15; // weight: -0.1250 - 346->82; // weight: 0.3750 - 346->90; // weight: 0.7500 - 351->6; // weight: -0.04688 - 351->77; // weight: 0.1406 - 351->7; // weight: 0.01562 - 351->78; // weight: -0.04688 - 351->15; // weight: -0.09375 - 351->82; // weight: 0.2812 - 351->85; // weight: 0.2812 - 351->86; // weight: -0.09375 - 351->90; // weight: 0.5625 - 301->85; // weight: -0.1250 - 301->86; // weight: 0.3750 - 301->90; // weight: 0.7500 - 305->6; // weight: -0.04688 - 305->77; // weight: 0.01562 - 305->7; // weight: 0.1406 - 305->78; // weight: -0.04688 - 305->15; // weight: 0.2812 - 305->82; // weight: -0.09375 - 305->85; // weight: -0.09375 - 305->86; // weight: 0.2812 - 305->90; // weight: 0.5625 - 357->77; // weight: -0.1250 - 357->78; // weight: 0.3750 - 357->82; // weight: 0.7500 - 361->6; // weight: 0.01562 - 361->77; // weight: -0.04688 - 361->7; // weight: -0.04688 - 361->78; // weight: 0.1406 - 361->15; // weight: -0.09375 - 361->82; // weight: 0.2812 - 361->85; // weight: -0.09375 - 361->86; // weight: 0.2812 - 361->90; // weight: 0.5625 - 111->7; // weight: -0.3333 - 111->78; // weight: 0.3333 - 111->110; // weight: 1.000 - 115->48; // weight: -0.3333 - 115->377; // weight: 0.3333 - 115->114; // weight: 1.000 - 103->78; // weight: -0.3333 - 103->377; // weight: 0.3333 - 103->102; // weight: 1.000 - 119->110; // weight: -0.3333 - 119->114; // weight: 0.3333 - 119->118; // weight: 1.000 - 120->94; // weight: -0.3333 - 120->102; // weight: 0.3333 - 120->118; // weight: 1.000 - 121->7; // weight: 0.1111 - 121->48; // weight: -0.1111 - 121->78; // weight: -0.1111 - 121->377; // weight: 0.1111 - 121->110; // weight: -0.3333 - 121->114; // weight: 0.3333 - 121->94; // weight: -0.3333 - 121->102; // weight: 0.3333 - 121->118; // weight: 1.000 - 296->7; // weight: 0.06250 - 296->48; // weight: -0.03125 - 296->78; // weight: -0.03125 - 296->377; // weight: 0.01562 - 296->110; // weight: -0.2813 - 296->114; // weight: 0.1406 - 296->94; // weight: -0.2813 - 296->102; // weight: 0.1406 - 296->118; // weight: 1.266 - 303->7; // weight: -0.04688 - 303->48; // weight: 0.02344 - 303->78; // weight: 0.0078125 - 303->377; // weight: -0.003906 - 303->110; // weight: -0.2109 - 303->114; // weight: 0.1055 - 303->94; // weight: 0.2109 - 303->102; // weight: -0.03516 - 303->118; // weight: 0.9492 - 300->7; // weight: -0.04688 - 300->48; // weight: 0.0078125 - 300->78; // weight: 0.02344 - 300->377; // weight: -0.003906 - 300->110; // weight: 0.2109 - 300->114; // weight: -0.03516 - 300->94; // weight: -0.2109 - 300->102; // weight: 0.1055 - 300->118; // weight: 0.9492 - 304->7; // weight: 0.03516 - 304->48; // weight: -0.005859 - 304->78; // weight: -0.005859 - 304->377; // weight: 0.0009766 - 304->110; // weight: 0.1582 - 304->114; // weight: -0.02637 - 304->94; // weight: 0.1582 - 304->102; // weight: -0.02637 - 304->118; // weight: 0.7119 - 327->48; // weight: -0.2500 - 327->377; // weight: 0.1250 - 327->114; // weight: 1.125 - 332->48; // weight: 0.1875 - 332->377; // weight: -0.03125 - 332->114; // weight: 0.8438 - 330->7; // weight: 0.07813 - 330->48; // weight: -0.1172 - 330->78; // weight: -0.03906 - 330->377; // weight: 0.05859 - 330->110; // weight: -0.3516 - 330->114; // weight: 0.5273 - 330->94; // weight: -0.2109 - 330->102; // weight: 0.1055 - 330->118; // weight: 0.9492 - 333->7; // weight: -0.05859 - 333->48; // weight: 0.08789 - 333->78; // weight: 0.009766 - 333->377; // weight: -0.01465 - 333->110; // weight: -0.2637 - 333->114; // weight: 0.3955 - 333->94; // weight: 0.1582 - 333->102; // weight: -0.02637 - 333->118; // weight: 0.7119 - 355->78; // weight: -0.2500 - 355->377; // weight: 0.1250 - 355->102; // weight: 1.125 - 359->7; // weight: 0.07813 - 359->48; // weight: -0.03906 - 359->78; // weight: -0.1172 - 359->377; // weight: 0.05859 - 359->110; // weight: -0.2109 - 359->114; // weight: 0.1055 - 359->94; // weight: -0.3516 - 359->102; // weight: 0.5273 - 359->118; // weight: 0.9492 - 356->78; // weight: 0.1875 - 356->377; // weight: -0.03125 - 356->102; // weight: 0.8438 - 360->7; // weight: -0.05859 - 360->48; // weight: 0.009766 - 360->78; // weight: 0.08789 - 360->377; // weight: -0.01465 - 360->110; // weight: 0.1582 - 360->114; // weight: -0.02637 - 360->94; // weight: -0.2637 - 360->102; // weight: 0.3955 - 360->118; // weight: 0.7119 - 380->48; // weight: -0.3125 - 380->377; // weight: 0.4688 - 380->114; // weight: 0.8438 - 378->78; // weight: -0.3125 - 378->377; // weight: 0.4688 - 378->102; // weight: 0.8438 - 381->7; // weight: 0.09766 - 381->48; // weight: -0.1465 - 381->78; // weight: -0.1465 - 381->377; // weight: 0.2197 - 381->110; // weight: -0.2637 - 381->114; // weight: 0.3955 - 381->94; // weight: -0.2637 - 381->102; // weight: 0.3955 - 381->118; // weight: 0.7119 - 107->78; // weight: -0.3333 - 107->261; // weight: 0.3333 - 107->106; // weight: 1.000 - 113->30; // weight: -0.3333 - 113->261; // weight: 0.3333 - 113->112; // weight: 1.000 - 127->98; // weight: -0.3333 - 127->106; // weight: 0.3333 - 127->126; // weight: 1.000 - 128->110; // weight: -0.3333 - 128->112; // weight: 0.3333 - 128->126; // weight: 1.000 - 129->7; // weight: 0.1111 - 129->78; // weight: -0.1111 - 129->30; // weight: -0.1111 - 129->261; // weight: 0.1111 - 129->98; // weight: -0.3333 - 129->106; // weight: 0.3333 - 129->110; // weight: -0.3333 - 129->112; // weight: 0.3333 - 129->126; // weight: 1.000 - 195->7; // weight: 0.06250 - 195->78; // weight: -0.03125 - 195->30; // weight: -0.03125 - 195->261; // weight: 0.01562 - 195->98; // weight: -0.2813 - 195->106; // weight: 0.1406 - 195->110; // weight: -0.2813 - 195->112; // weight: 0.1406 - 195->126; // weight: 1.266 - 201->7; // weight: -0.04688 - 201->78; // weight: 0.02344 - 201->30; // weight: 0.0078125 - 201->261; // weight: -0.003906 - 201->98; // weight: -0.2109 - 201->106; // weight: 0.1055 - 201->110; // weight: 0.2109 - 201->112; // weight: -0.03516 - 201->126; // weight: 0.9492 - 203->7; // weight: -0.04688 - 203->78; // weight: 0.0078125 - 203->30; // weight: 0.02344 - 203->261; // weight: -0.003906 - 203->98; // weight: 0.2109 - 203->106; // weight: -0.03516 - 203->110; // weight: -0.2109 - 203->112; // weight: 0.1055 - 203->126; // weight: 0.9492 - 206->7; // weight: 0.03516 - 206->78; // weight: -0.005859 - 206->30; // weight: -0.005859 - 206->261; // weight: 0.0009766 - 206->98; // weight: 0.1582 - 206->106; // weight: -0.02637 - 206->110; // weight: 0.1582 - 206->112; // weight: -0.02637 - 206->126; // weight: 0.7119 - 250->78; // weight: -0.2500 - 250->261; // weight: 0.1250 - 250->106; // weight: 1.125 - 253->78; // weight: 0.1875 - 253->261; // weight: -0.03125 - 253->106; // weight: 0.8438 - 255->7; // weight: 0.07813 - 255->78; // weight: -0.1172 - 255->30; // weight: -0.03906 - 255->261; // weight: 0.05859 - 255->98; // weight: -0.3516 - 255->106; // weight: 0.5273 - 255->110; // weight: -0.2109 - 255->112; // weight: 0.1055 - 255->126; // weight: 0.9492 - 258->7; // weight: -0.05859 - 258->78; // weight: 0.08789 - 258->30; // weight: 0.009766 - 258->261; // weight: -0.01465 - 258->98; // weight: -0.2637 - 258->106; // weight: 0.3955 - 258->110; // weight: 0.1582 - 258->112; // weight: -0.02637 - 258->126; // weight: 0.7119 - 210->30; // weight: -0.2500 - 210->261; // weight: 0.1250 - 210->112; // weight: 1.125 - 214->7; // weight: 0.07813 - 214->78; // weight: -0.03906 - 214->30; // weight: -0.1172 - 214->261; // weight: 0.05859 - 214->98; // weight: -0.2109 - 214->106; // weight: 0.1055 - 214->110; // weight: -0.3516 - 214->112; // weight: 0.5273 - 214->126; // weight: 0.9492 - 215->30; // weight: 0.1875 - 215->261; // weight: -0.03125 - 215->112; // weight: 0.8438 - 217->7; // weight: -0.05859 - 217->78; // weight: 0.009766 - 217->30; // weight: 0.08789 - 217->261; // weight: -0.01465 - 217->98; // weight: 0.1582 - 217->106; // weight: -0.02637 - 217->110; // weight: -0.2637 - 217->112; // weight: 0.3955 - 217->126; // weight: 0.7119 - 263->78; // weight: -0.3125 - 263->261; // weight: 0.4688 - 263->106; // weight: 0.8438 - 264->30; // weight: -0.3125 - 264->261; // weight: 0.4688 - 264->112; // weight: 0.8438 - 266->7; // weight: 0.09766 - 266->78; // weight: -0.1465 - 266->30; // weight: -0.1465 - 266->261; // weight: 0.2197 - 266->98; // weight: -0.2637 - 266->106; // weight: 0.3955 - 266->110; // weight: -0.2637 - 266->112; // weight: 0.3955 - 266->126; // weight: 0.7119 -} -DEAL:: Number of degrees of freedom: 385 -DEAL:: Number of constraints : 128 -DEAL:cg::Starting value 0.3371 -DEAL:cg::Convergence step 11 value 6.990e-10 -DEAL::Cycle 2: -DEAL:: Number of active cells: 64 -digraph constraints { - 49->2; // weight: 0.2222 - 49->3; // weight: -0.1111 - 49->11; // weight: 0.8889 - 50->2; // weight: -0.1111 - 50->3; // weight: 0.2222 - 50->11; // weight: 0.8889 - 57->6; // weight: 0.2222 - 57->7; // weight: -0.1111 - 57->15; // weight: 0.8889 - 58->6; // weight: -0.1111 - 58->7; // weight: 0.2222 - 58->15; // weight: 0.8889 - 61->2; // weight: 0.2222 - 61->6; // weight: -0.1111 - 61->18; // weight: 0.8889 - 62->2; // weight: -0.1111 - 62->6; // weight: 0.2222 - 62->18; // weight: 0.8889 - 63->3; // weight: 0.2222 - 63->7; // weight: -0.1111 - 63->19; // weight: 0.8889 - 64->3; // weight: -0.1111 - 64->7; // weight: 0.2222 - 64->19; // weight: 0.8889 - 77->2; // weight: 0.04938 - 77->6; // weight: -0.02469 - 77->3; // weight: -0.02469 - 77->7; // weight: 0.01235 - 77->11; // weight: 0.1975 - 77->15; // weight: -0.09877 - 77->18; // weight: 0.1975 - 77->19; // weight: -0.09877 - 77->23; // weight: 0.7901 - 78->2; // weight: -0.02469 - 78->6; // weight: 0.04938 - 78->3; // weight: 0.01235 - 78->7; // weight: -0.02469 - 78->11; // weight: -0.09877 - 78->15; // weight: 0.1975 - 78->18; // weight: 0.1975 - 78->19; // weight: -0.09877 - 78->23; // weight: 0.7901 - 79->2; // weight: -0.02469 - 79->6; // weight: 0.01235 - 79->3; // weight: 0.04938 - 79->7; // weight: -0.02469 - 79->11; // weight: 0.1975 - 79->15; // weight: -0.09877 - 79->18; // weight: -0.09877 - 79->19; // weight: 0.1975 - 79->23; // weight: 0.7901 - 80->2; // weight: 0.01235 - 80->6; // weight: -0.02469 - 80->3; // weight: -0.02469 - 80->7; // weight: 0.04938 - 80->11; // weight: -0.09877 - 80->15; // weight: 0.1975 - 80->18; // weight: -0.09877 - 80->19; // weight: 0.1975 - 80->23; // weight: 0.7901 - 67->101; // weight: 0.2222 - 67->103; // weight: -0.1111 - 67->111; // weight: 0.8889 - 68->101; // weight: -0.1111 - 68->103; // weight: 0.2222 - 68->111; // weight: 0.8889 - 47->3; // weight: 0.2222 - 47->101; // weight: -0.1111 - 47->105; // weight: 0.8889 - 48->3; // weight: -0.1111 - 48->101; // weight: 0.2222 - 48->105; // weight: 0.8889 - 55->7; // weight: 0.2222 - 55->103; // weight: -0.1111 - 55->108; // weight: 0.8889 - 56->7; // weight: -0.1111 - 56->103; // weight: 0.2222 - 56->108; // weight: 0.8889 - 73->3; // weight: 0.04938 - 73->101; // weight: -0.02469 - 73->7; // weight: -0.02469 - 73->103; // weight: 0.01235 - 73->19; // weight: 0.1975 - 73->111; // weight: -0.09877 - 73->105; // weight: 0.1975 - 73->108; // weight: -0.09877 - 73->113; // weight: 0.7901 - 74->3; // weight: -0.02469 - 74->101; // weight: 0.04938 - 74->7; // weight: 0.01235 - 74->103; // weight: -0.02469 - 74->19; // weight: -0.09877 - 74->111; // weight: 0.1975 - 74->105; // weight: 0.1975 - 74->108; // weight: -0.09877 - 74->113; // weight: 0.7901 - 75->3; // weight: -0.02469 - 75->101; // weight: 0.01235 - 75->7; // weight: 0.04938 - 75->103; // weight: -0.02469 - 75->19; // weight: 0.1975 - 75->111; // weight: -0.09877 - 75->105; // weight: -0.09877 - 75->108; // weight: 0.1975 - 75->113; // weight: 0.7901 - 76->3; // weight: 0.01235 - 76->101; // weight: -0.02469 - 76->7; // weight: -0.02469 - 76->103; // weight: 0.04938 - 76->19; // weight: -0.09877 - 76->111; // weight: 0.1975 - 76->105; // weight: -0.09877 - 76->108; // weight: 0.1975 - 76->113; // weight: 0.7901 - 809->101; // weight: 0.2222 - 809->102; // weight: -0.1111 - 809->107; // weight: 0.8889 - 810->101; // weight: -0.1111 - 810->102; // weight: 0.2222 - 810->107; // weight: 0.8889 - 815->103; // weight: 0.2222 - 815->104; // weight: -0.1111 - 815->110; // weight: 0.8889 - 816->103; // weight: -0.1111 - 816->104; // weight: 0.2222 - 816->110; // weight: 0.8889 - 819->102; // weight: 0.2222 - 819->104; // weight: -0.1111 - 819->112; // weight: 0.8889 - 820->102; // weight: -0.1111 - 820->104; // weight: 0.2222 - 820->112; // weight: 0.8889 - 827->101; // weight: 0.04938 - 827->103; // weight: -0.02469 - 827->102; // weight: -0.02469 - 827->104; // weight: 0.01235 - 827->107; // weight: 0.1975 - 827->110; // weight: -0.09877 - 827->111; // weight: 0.1975 - 827->112; // weight: -0.09877 - 827->115; // weight: 0.7901 - 828->101; // weight: -0.02469 - 828->103; // weight: 0.04938 - 828->102; // weight: 0.01235 - 828->104; // weight: -0.02469 - 828->107; // weight: -0.09877 - 828->110; // weight: 0.1975 - 828->111; // weight: 0.1975 - 828->112; // weight: -0.09877 - 828->115; // weight: 0.7901 - 829->101; // weight: -0.02469 - 829->103; // weight: 0.01235 - 829->102; // weight: 0.04938 - 829->104; // weight: -0.02469 - 829->107; // weight: 0.1975 - 829->110; // weight: -0.09877 - 829->111; // weight: -0.09877 - 829->112; // weight: 0.1975 - 829->115; // weight: 0.7901 - 830->101; // weight: 0.01235 - 830->103; // weight: -0.02469 - 830->102; // weight: -0.02469 - 830->104; // weight: 0.04938 - 830->107; // weight: -0.09877 - 830->110; // weight: 0.1975 - 830->111; // weight: -0.09877 - 830->112; // weight: 0.1975 - 830->115; // weight: 0.7901 - 59->149; // weight: 0.2222 - 59->103; // weight: -0.1111 - 59->153; // weight: 0.8889 - 60->149; // weight: -0.1111 - 60->103; // weight: 0.2222 - 60->153; // weight: 0.8889 - 936->150; // weight: 0.2222 - 936->151; // weight: -0.1111 - 936->156; // weight: 0.8889 - 937->150; // weight: -0.1111 - 937->151; // weight: 0.2222 - 937->156; // weight: 0.8889 - 940->149; // weight: 0.2222 - 940->150; // weight: -0.1111 - 940->157; // weight: 0.8889 - 941->149; // weight: -0.1111 - 941->150; // weight: 0.2222 - 941->157; // weight: 0.8889 - 942->103; // weight: 0.2222 - 942->151; // weight: -0.1111 - 942->158; // weight: 0.8889 - 943->103; // weight: -0.1111 - 943->151; // weight: 0.2222 - 943->158; // weight: 0.8889 - 956->149; // weight: 0.04938 - 956->150; // weight: -0.02469 - 956->103; // weight: -0.02469 - 956->151; // weight: 0.01235 - 956->153; // weight: 0.1975 - 956->156; // weight: -0.09877 - 956->157; // weight: 0.1975 - 956->158; // weight: -0.09877 - 956->161; // weight: 0.7901 - 957->149; // weight: -0.02469 - 957->150; // weight: 0.04938 - 957->103; // weight: 0.01235 - 957->151; // weight: -0.02469 - 957->153; // weight: -0.09877 - 957->156; // weight: 0.1975 - 957->157; // weight: 0.1975 - 957->158; // weight: -0.09877 - 957->161; // weight: 0.7901 - 958->149; // weight: -0.02469 - 958->150; // weight: 0.01235 - 958->103; // weight: 0.04938 - 958->151; // weight: -0.02469 - 958->153; // weight: 0.1975 - 958->156; // weight: -0.09877 - 958->157; // weight: -0.09877 - 958->158; // weight: 0.1975 - 958->161; // weight: 0.7901 - 959->149; // weight: 0.01235 - 959->150; // weight: -0.02469 - 959->103; // weight: -0.02469 - 959->151; // weight: 0.04938 - 959->153; // weight: -0.09877 - 959->156; // weight: 0.1975 - 959->157; // weight: -0.09877 - 959->158; // weight: 0.1975 - 959->161; // weight: 0.7901 - 53->6; // weight: 0.2222 - 53->149; // weight: -0.1111 - 53->152; // weight: 0.8889 - 54->6; // weight: -0.1111 - 54->149; // weight: 0.2222 - 54->152; // weight: 0.8889 - 89->6; // weight: 0.04938 - 89->7; // weight: -0.02469 - 89->149; // weight: -0.02469 - 89->103; // weight: 0.01235 - 89->152; // weight: 0.1975 - 89->108; // weight: -0.09877 - 89->15; // weight: 0.1975 - 89->153; // weight: -0.09877 - 89->162; // weight: 0.7901 - 90->6; // weight: -0.02469 - 90->7; // weight: 0.04938 - 90->149; // weight: 0.01235 - 90->103; // weight: -0.02469 - 90->152; // weight: -0.09877 - 90->108; // weight: 0.1975 - 90->15; // weight: 0.1975 - 90->153; // weight: -0.09877 - 90->162; // weight: 0.7901 - 91->6; // weight: -0.02469 - 91->7; // weight: 0.01235 - 91->149; // weight: 0.04938 - 91->103; // weight: -0.02469 - 91->152; // weight: 0.1975 - 91->108; // weight: -0.09877 - 91->15; // weight: -0.09877 - 91->153; // weight: 0.1975 - 91->162; // weight: 0.7901 - 92->6; // weight: 0.01235 - 92->7; // weight: -0.02469 - 92->149; // weight: -0.02469 - 92->103; // weight: 0.04938 - 92->152; // weight: -0.09877 - 92->108; // weight: 0.1975 - 92->15; // weight: -0.09877 - 92->153; // weight: 0.1975 - 92->162; // weight: 0.7901 - 979->151; // weight: 0.2222 - 979->165; // weight: -0.1111 - 979->167; // weight: 0.8889 - 980->151; // weight: -0.1111 - 980->165; // weight: 0.2222 - 980->167; // weight: 0.8889 - 983->104; // weight: 0.2222 - 983->165; // weight: -0.1111 - 983->168; // weight: 0.8889 - 984->104; // weight: -0.1111 - 984->165; // weight: 0.2222 - 984->168; // weight: 0.8889 - 991->103; // weight: 0.04938 - 991->151; // weight: -0.02469 - 991->104; // weight: -0.02469 - 991->165; // weight: 0.01235 - 991->110; // weight: 0.1975 - 991->167; // weight: -0.09877 - 991->158; // weight: 0.1975 - 991->168; // weight: -0.09877 - 991->170; // weight: 0.7901 - 992->103; // weight: -0.02469 - 992->151; // weight: 0.04938 - 992->104; // weight: 0.01235 - 992->165; // weight: -0.02469 - 992->110; // weight: -0.09877 - 992->167; // weight: 0.1975 - 992->158; // weight: 0.1975 - 992->168; // weight: -0.09877 - 992->170; // weight: 0.7901 - 993->103; // weight: -0.02469 - 993->151; // weight: 0.01235 - 993->104; // weight: 0.04938 - 993->165; // weight: -0.02469 - 993->110; // weight: 0.1975 - 993->167; // weight: -0.09877 - 993->158; // weight: -0.09877 - 993->168; // weight: 0.1975 - 993->170; // weight: 0.7901 - 994->103; // weight: 0.01235 - 994->151; // weight: -0.02469 - 994->104; // weight: -0.02469 - 994->165; // weight: 0.04938 - 994->110; // weight: -0.09877 - 994->167; // weight: 0.1975 - 994->158; // weight: -0.09877 - 994->168; // weight: 0.1975 - 994->170; // weight: 0.7901 - 216->174; // weight: 0.2222 - 216->178; // weight: -0.1111 - 216->190; // weight: 0.8889 - 217->174; // weight: -0.1111 - 217->178; // weight: 0.2222 - 217->190; // weight: 0.8889 - 218->176; // weight: 0.2222 - 218->180; // weight: -0.1111 - 218->192; // weight: 0.8889 - 219->176; // weight: -0.1111 - 219->180; // weight: 0.2222 - 219->192; // weight: 0.8889 - 200->174; // weight: 0.2222 - 200->176; // weight: -0.1111 - 200->182; // weight: 0.8889 - 201->174; // weight: -0.1111 - 201->176; // weight: 0.2222 - 201->182; // weight: 0.8889 - 208->178; // weight: 0.2222 - 208->180; // weight: -0.1111 - 208->186; // weight: 0.8889 - 209->178; // weight: -0.1111 - 209->180; // weight: 0.2222 - 209->186; // weight: 0.8889 - 222->174; // weight: 0.04938 - 222->176; // weight: -0.02469 - 222->178; // weight: -0.02469 - 222->180; // weight: 0.01235 - 222->190; // weight: 0.1975 - 222->192; // weight: -0.09877 - 222->182; // weight: 0.1975 - 222->186; // weight: -0.09877 - 222->194; // weight: 0.7901 - 223->174; // weight: -0.02469 - 223->176; // weight: 0.04938 - 223->178; // weight: 0.01235 - 223->180; // weight: -0.02469 - 223->190; // weight: -0.09877 - 223->192; // weight: 0.1975 - 223->182; // weight: 0.1975 - 223->186; // weight: -0.09877 - 223->194; // weight: 0.7901 - 224->174; // weight: -0.02469 - 224->176; // weight: 0.01235 - 224->178; // weight: 0.04938 - 224->180; // weight: -0.02469 - 224->190; // weight: 0.1975 - 224->192; // weight: -0.09877 - 224->182; // weight: -0.09877 - 224->186; // weight: 0.1975 - 224->194; // weight: 0.7901 - 225->174; // weight: 0.01235 - 225->176; // weight: -0.02469 - 225->178; // weight: -0.02469 - 225->180; // weight: 0.04938 - 225->190; // weight: -0.09877 - 225->192; // weight: 0.1975 - 225->182; // weight: -0.09877 - 225->186; // weight: 0.1975 - 225->194; // weight: 0.7901 - 220->272; // weight: 0.2222 - 220->274; // weight: -0.1111 - 220->282; // weight: 0.8889 - 221->272; // weight: -0.1111 - 221->274; // weight: 0.2222 - 221->282; // weight: 0.8889 - 864->273; // weight: 0.2222 - 864->275; // weight: -0.1111 - 864->283; // weight: 0.8889 - 865->273; // weight: -0.1111 - 865->275; // weight: 0.2222 - 865->283; // weight: 0.8889 - 852->272; // weight: 0.2222 - 852->273; // weight: -0.1111 - 852->276; // weight: 0.8889 - 853->272; // weight: -0.1111 - 853->273; // weight: 0.2222 - 853->276; // weight: 0.8889 - 858->274; // weight: 0.2222 - 858->275; // weight: -0.1111 - 858->279; // weight: 0.8889 - 859->274; // weight: -0.1111 - 859->275; // weight: 0.2222 - 859->279; // weight: 0.8889 - 868->272; // weight: 0.04938 - 868->273; // weight: -0.02469 - 868->274; // weight: -0.02469 - 868->275; // weight: 0.01235 - 868->282; // weight: 0.1975 - 868->283; // weight: -0.09877 - 868->276; // weight: 0.1975 - 868->279; // weight: -0.09877 - 868->284; // weight: 0.7901 - 869->272; // weight: -0.02469 - 869->273; // weight: 0.04938 - 869->274; // weight: 0.01235 - 869->275; // weight: -0.02469 - 869->282; // weight: -0.09877 - 869->283; // weight: 0.1975 - 869->276; // weight: 0.1975 - 869->279; // weight: -0.09877 - 869->284; // weight: 0.7901 - 870->272; // weight: -0.02469 - 870->273; // weight: 0.01235 - 870->274; // weight: 0.04938 - 870->275; // weight: -0.02469 - 870->282; // weight: 0.1975 - 870->283; // weight: -0.09877 - 870->276; // weight: -0.09877 - 870->279; // weight: 0.1975 - 870->284; // weight: 0.7901 - 871->272; // weight: 0.01235 - 871->273; // weight: -0.02469 - 871->274; // weight: -0.02469 - 871->275; // weight: 0.04938 - 871->282; // weight: -0.09877 - 871->283; // weight: 0.1975 - 871->276; // weight: -0.09877 - 871->279; // weight: 0.1975 - 871->284; // weight: 0.7901 - 206->176; // weight: 0.2222 - 206->272; // weight: -0.1111 - 206->277; // weight: 0.8889 - 207->176; // weight: -0.1111 - 207->272; // weight: 0.2222 - 207->277; // weight: 0.8889 - 214->180; // weight: 0.2222 - 214->274; // weight: -0.1111 - 214->280; // weight: 0.8889 - 215->180; // weight: -0.1111 - 215->274; // weight: 0.2222 - 215->280; // weight: 0.8889 - 234->176; // weight: 0.04938 - 234->180; // weight: -0.02469 - 234->272; // weight: -0.02469 - 234->274; // weight: 0.01235 - 234->277; // weight: 0.1975 - 234->280; // weight: -0.09877 - 234->192; // weight: 0.1975 - 234->282; // weight: -0.09877 - 234->285; // weight: 0.7901 - 235->176; // weight: -0.02469 - 235->180; // weight: 0.04938 - 235->272; // weight: 0.01235 - 235->274; // weight: -0.02469 - 235->277; // weight: -0.09877 - 235->280; // weight: 0.1975 - 235->192; // weight: 0.1975 - 235->282; // weight: -0.09877 - 235->285; // weight: 0.7901 - 236->176; // weight: -0.02469 - 236->180; // weight: 0.01235 - 236->272; // weight: 0.04938 - 236->274; // weight: -0.02469 - 236->277; // weight: 0.1975 - 236->280; // weight: -0.09877 - 236->192; // weight: -0.09877 - 236->282; // weight: 0.1975 - 236->285; // weight: 0.7901 - 237->176; // weight: 0.01235 - 237->180; // weight: -0.02469 - 237->272; // weight: -0.02469 - 237->274; // weight: 0.04938 - 237->277; // weight: -0.09877 - 237->280; // weight: 0.1975 - 237->192; // weight: -0.09877 - 237->282; // weight: 0.1975 - 237->285; // weight: 0.7901 - 944->274; // weight: 0.2222 - 944->308; // weight: -0.1111 - 944->314; // weight: 0.8889 - 945->274; // weight: -0.1111 - 945->308; // weight: 0.2222 - 945->314; // weight: 0.8889 - 210->149; // weight: 0.2222 - 210->274; // weight: -0.1111 - 210->309; // weight: 0.8889 - 211->149; // weight: -0.1111 - 211->274; // weight: 0.2222 - 211->309; // weight: 0.8889 - 932->150; // weight: 0.2222 - 932->308; // weight: -0.1111 - 932->311; // weight: 0.8889 - 933->150; // weight: -0.1111 - 933->308; // weight: 0.2222 - 933->311; // weight: 0.8889 - 948->149; // weight: 0.04938 - 948->274; // weight: -0.02469 - 948->150; // weight: -0.02469 - 948->308; // weight: 0.01235 - 948->157; // weight: 0.1975 - 948->314; // weight: -0.09877 - 948->309; // weight: 0.1975 - 948->311; // weight: -0.09877 - 948->315; // weight: 0.7901 - 949->149; // weight: -0.02469 - 949->274; // weight: 0.04938 - 949->150; // weight: 0.01235 - 949->308; // weight: -0.02469 - 949->157; // weight: -0.09877 - 949->314; // weight: 0.1975 - 949->309; // weight: 0.1975 - 949->311; // weight: -0.09877 - 949->315; // weight: 0.7901 - 950->149; // weight: -0.02469 - 950->274; // weight: 0.01235 - 950->150; // weight: 0.04938 - 950->308; // weight: -0.02469 - 950->157; // weight: 0.1975 - 950->314; // weight: -0.09877 - 950->309; // weight: -0.09877 - 950->311; // weight: 0.1975 - 950->315; // weight: 0.7901 - 951->149; // weight: 0.01235 - 951->274; // weight: -0.02469 - 951->150; // weight: -0.02469 - 951->308; // weight: 0.04938 - 951->157; // weight: -0.09877 - 951->314; // weight: 0.1975 - 951->309; // weight: -0.09877 - 951->311; // weight: 0.1975 - 951->315; // weight: 0.7901 - 212->178; // weight: 0.2222 - 212->149; // weight: -0.1111 - 212->310; // weight: 0.8889 - 213->178; // weight: -0.1111 - 213->149; // weight: 0.2222 - 213->310; // weight: 0.8889 - 242->178; // weight: 0.04938 - 242->149; // weight: -0.02469 - 242->180; // weight: -0.02469 - 242->274; // weight: 0.01235 - 242->186; // weight: 0.1975 - 242->309; // weight: -0.09877 - 242->310; // weight: 0.1975 - 242->280; // weight: -0.09877 - 242->318; // weight: 0.7901 - 243->178; // weight: -0.02469 - 243->149; // weight: 0.04938 - 243->180; // weight: 0.01235 - 243->274; // weight: -0.02469 - 243->186; // weight: -0.09877 - 243->309; // weight: 0.1975 - 243->310; // weight: 0.1975 - 243->280; // weight: -0.09877 - 243->318; // weight: 0.7901 - 244->178; // weight: -0.02469 - 244->149; // weight: 0.01235 - 244->180; // weight: 0.04938 - 244->274; // weight: -0.02469 - 244->186; // weight: 0.1975 - 244->309; // weight: -0.09877 - 244->310; // weight: -0.09877 - 244->280; // weight: 0.1975 - 244->318; // weight: 0.7901 - 245->178; // weight: 0.01235 - 245->149; // weight: -0.02469 - 245->180; // weight: -0.02469 - 245->274; // weight: 0.04938 - 245->186; // weight: -0.09877 - 245->309; // weight: 0.1975 - 245->310; // weight: -0.09877 - 245->280; // weight: 0.1975 - 245->318; // weight: 0.7901 - 1018->275; // weight: 0.2222 - 1018->333; // weight: -0.1111 - 1018->336; // weight: 0.8889 - 1019->275; // weight: -0.1111 - 1019->333; // weight: 0.2222 - 1019->336; // weight: 0.8889 - 1012->308; // weight: 0.2222 - 1012->333; // weight: -0.1111 - 1012->334; // weight: 0.8889 - 1013->308; // weight: -0.1111 - 1013->333; // weight: 0.2222 - 1013->334; // weight: 0.8889 - 1022->274; // weight: 0.04938 - 1022->275; // weight: -0.02469 - 1022->308; // weight: -0.02469 - 1022->333; // weight: 0.01235 - 1022->314; // weight: 0.1975 - 1022->336; // weight: -0.09877 - 1022->279; // weight: 0.1975 - 1022->334; // weight: -0.09877 - 1022->337; // weight: 0.7901 - 1023->274; // weight: -0.02469 - 1023->275; // weight: 0.04938 - 1023->308; // weight: 0.01235 - 1023->333; // weight: -0.02469 - 1023->314; // weight: -0.09877 - 1023->336; // weight: 0.1975 - 1023->279; // weight: 0.1975 - 1023->334; // weight: -0.09877 - 1023->337; // weight: 0.7901 - 1024->274; // weight: -0.02469 - 1024->275; // weight: 0.01235 - 1024->308; // weight: 0.04938 - 1024->333; // weight: -0.02469 - 1024->314; // weight: 0.1975 - 1024->336; // weight: -0.09877 - 1024->279; // weight: -0.09877 - 1024->334; // weight: 0.1975 - 1024->337; // weight: 0.7901 - 1025->274; // weight: 0.01235 - 1025->275; // weight: -0.02469 - 1025->308; // weight: -0.02469 - 1025->333; // weight: 0.04938 - 1025->314; // weight: -0.09877 - 1025->336; // weight: 0.1975 - 1025->279; // weight: -0.09877 - 1025->334; // weight: 0.1975 - 1025->337; // weight: 0.7901 - 45->2; // weight: 0.2222 - 45->452; // weight: -0.1111 - 45->453; // weight: 0.8889 - 46->2; // weight: -0.1111 - 46->452; // weight: 0.2222 - 46->453; // weight: 0.8889 - 51->452; // weight: 0.2222 - 51->101; // weight: -0.1111 - 51->532; // weight: 0.8889 - 52->452; // weight: -0.1111 - 52->101; // weight: 0.2222 - 52->532; // weight: 0.8889 - 85->2; // weight: 0.04938 - 85->3; // weight: -0.02469 - 85->452; // weight: -0.02469 - 85->101; // weight: 0.01235 - 85->453; // weight: 0.1975 - 85->105; // weight: -0.09877 - 85->11; // weight: 0.1975 - 85->532; // weight: -0.09877 - 85->536; // weight: 0.7901 - 86->2; // weight: -0.02469 - 86->3; // weight: 0.04938 - 86->452; // weight: 0.01235 - 86->101; // weight: -0.02469 - 86->453; // weight: -0.09877 - 86->105; // weight: 0.1975 - 86->11; // weight: 0.1975 - 86->532; // weight: -0.09877 - 86->536; // weight: 0.7901 - 87->2; // weight: -0.02469 - 87->3; // weight: 0.01235 - 87->452; // weight: 0.04938 - 87->101; // weight: -0.02469 - 87->453; // weight: 0.1975 - 87->105; // weight: -0.09877 - 87->11; // weight: -0.09877 - 87->532; // weight: 0.1975 - 87->536; // weight: 0.7901 - 88->2; // weight: 0.01235 - 88->3; // weight: -0.02469 - 88->452; // weight: -0.02469 - 88->101; // weight: 0.04938 - 88->453; // weight: -0.09877 - 88->105; // weight: 0.1975 - 88->11; // weight: -0.09877 - 88->532; // weight: 0.1975 - 88->536; // weight: 0.7901 - 202->452; // weight: 0.2222 - 202->272; // weight: -0.1111 - 202->608; // weight: 0.8889 - 203->452; // weight: -0.1111 - 203->272; // weight: 0.2222 - 203->608; // weight: 0.8889 - 204->174; // weight: 0.2222 - 204->452; // weight: -0.1111 - 204->454; // weight: 0.8889 - 205->174; // weight: -0.1111 - 205->452; // weight: 0.2222 - 205->454; // weight: 0.8889 - 238->174; // weight: 0.04938 - 238->452; // weight: -0.02469 - 238->176; // weight: -0.02469 - 238->272; // weight: 0.01235 - 238->182; // weight: 0.1975 - 238->608; // weight: -0.09877 - 238->454; // weight: 0.1975 - 238->277; // weight: -0.09877 - 238->612; // weight: 0.7901 - 239->174; // weight: -0.02469 - 239->452; // weight: 0.04938 - 239->176; // weight: 0.01235 - 239->272; // weight: -0.02469 - 239->182; // weight: -0.09877 - 239->608; // weight: 0.1975 - 239->454; // weight: 0.1975 - 239->277; // weight: -0.09877 - 239->612; // weight: 0.7901 - 240->174; // weight: -0.02469 - 240->452; // weight: 0.01235 - 240->176; // weight: 0.04938 - 240->272; // weight: -0.02469 - 240->182; // weight: 0.1975 - 240->608; // weight: -0.09877 - 240->454; // weight: -0.09877 - 240->277; // weight: 0.1975 - 240->612; // weight: 0.7901 - 241->174; // weight: 0.01235 - 241->452; // weight: -0.02469 - 241->176; // weight: -0.02469 - 241->272; // weight: 0.04938 - 241->182; // weight: -0.09877 - 241->608; // weight: 0.1975 - 241->454; // weight: -0.09877 - 241->277; // weight: 0.1975 - 241->612; // weight: 0.7901 - 772->101; // weight: 0.2222 - 772->672; // weight: -0.1111 - 772->673; // weight: 0.8889 - 773->101; // weight: -0.1111 - 773->672; // weight: 0.2222 - 773->673; // weight: 0.8889 - 774->272; // weight: 0.2222 - 774->672; // weight: -0.1111 - 774->674; // weight: 0.8889 - 775->272; // weight: -0.1111 - 775->672; // weight: 0.2222 - 775->674; // weight: 0.8889 - 790->452; // weight: 0.04938 - 790->101; // weight: -0.02469 - 790->272; // weight: -0.02469 - 790->672; // weight: 0.01235 - 790->608; // weight: 0.1975 - 790->673; // weight: -0.09877 - 790->532; // weight: 0.1975 - 790->674; // weight: -0.09877 - 790->678; // weight: 0.7901 - 791->452; // weight: -0.02469 - 791->101; // weight: 0.04938 - 791->272; // weight: 0.01235 - 791->672; // weight: -0.02469 - 791->608; // weight: -0.09877 - 791->673; // weight: 0.1975 - 791->532; // weight: 0.1975 - 791->674; // weight: -0.09877 - 791->678; // weight: 0.7901 - 792->452; // weight: -0.02469 - 792->101; // weight: 0.01235 - 792->272; // weight: 0.04938 - 792->672; // weight: -0.02469 - 792->608; // weight: 0.1975 - 792->673; // weight: -0.09877 - 792->532; // weight: -0.09877 - 792->674; // weight: 0.1975 - 792->678; // weight: 0.7901 - 793->452; // weight: 0.01235 - 793->101; // weight: -0.02469 - 793->272; // weight: -0.02469 - 793->672; // weight: 0.04938 - 793->608; // weight: -0.09877 - 793->673; // weight: 0.1975 - 793->532; // weight: -0.09877 - 793->674; // weight: 0.1975 - 793->678; // weight: 0.7901 - 807->102; // weight: 0.2222 - 807->680; // weight: -0.1111 - 807->681; // weight: 0.8889 - 808->102; // weight: -0.1111 - 808->680; // weight: 0.2222 - 808->681; // weight: 0.8889 - 811->672; // weight: 0.2222 - 811->680; // weight: -0.1111 - 811->682; // weight: 0.8889 - 812->672; // weight: -0.1111 - 812->680; // weight: 0.2222 - 812->682; // weight: 0.8889 - 835->101; // weight: 0.04938 - 835->102; // weight: -0.02469 - 835->672; // weight: -0.02469 - 835->680; // weight: 0.01235 - 835->673; // weight: 0.1975 - 835->681; // weight: -0.09877 - 835->107; // weight: 0.1975 - 835->682; // weight: -0.09877 - 835->686; // weight: 0.7901 - 836->101; // weight: -0.02469 - 836->102; // weight: 0.04938 - 836->672; // weight: 0.01235 - 836->680; // weight: -0.02469 - 836->673; // weight: -0.09877 - 836->681; // weight: 0.1975 - 836->107; // weight: 0.1975 - 836->682; // weight: -0.09877 - 836->686; // weight: 0.7901 - 837->101; // weight: -0.02469 - 837->102; // weight: 0.01235 - 837->672; // weight: 0.04938 - 837->680; // weight: -0.02469 - 837->673; // weight: 0.1975 - 837->681; // weight: -0.09877 - 837->107; // weight: -0.09877 - 837->682; // weight: 0.1975 - 837->686; // weight: 0.7901 - 838->101; // weight: 0.01235 - 838->102; // weight: -0.02469 - 838->672; // weight: -0.02469 - 838->680; // weight: 0.04938 - 838->673; // weight: -0.09877 - 838->681; // weight: 0.1975 - 838->107; // weight: -0.09877 - 838->682; // weight: 0.1975 - 838->686; // weight: 0.7901 - 854->672; // weight: 0.2222 - 854->688; // weight: -0.1111 - 854->689; // weight: 0.8889 - 855->672; // weight: -0.1111 - 855->688; // weight: 0.2222 - 855->689; // weight: 0.8889 - 856->273; // weight: 0.2222 - 856->688; // weight: -0.1111 - 856->690; // weight: 0.8889 - 857->273; // weight: -0.1111 - 857->688; // weight: 0.2222 - 857->690; // weight: 0.8889 - 880->272; // weight: 0.04938 - 880->672; // weight: -0.02469 - 880->273; // weight: -0.02469 - 880->688; // weight: 0.01235 - 880->276; // weight: 0.1975 - 880->689; // weight: -0.09877 - 880->674; // weight: 0.1975 - 880->690; // weight: -0.09877 - 880->694; // weight: 0.7901 - 881->272; // weight: -0.02469 - 881->672; // weight: 0.04938 - 881->273; // weight: 0.01235 - 881->688; // weight: -0.02469 - 881->276; // weight: -0.09877 - 881->689; // weight: 0.1975 - 881->674; // weight: 0.1975 - 881->690; // weight: -0.09877 - 881->694; // weight: 0.7901 - 882->272; // weight: -0.02469 - 882->672; // weight: 0.01235 - 882->273; // weight: 0.04938 - 882->688; // weight: -0.02469 - 882->276; // weight: 0.1975 - 882->689; // weight: -0.09877 - 882->674; // weight: -0.09877 - 882->690; // weight: 0.1975 - 882->694; // weight: 0.7901 - 883->272; // weight: 0.01235 - 883->672; // weight: -0.02469 - 883->273; // weight: -0.02469 - 883->688; // weight: 0.04938 - 883->276; // weight: -0.09877 - 883->689; // weight: 0.1975 - 883->674; // weight: -0.09877 - 883->690; // weight: 0.1975 - 883->694; // weight: 0.7901 - 897->680; // weight: 0.2222 - 897->696; // weight: -0.1111 - 897->697; // weight: 0.8889 - 898->680; // weight: -0.1111 - 898->696; // weight: 0.2222 - 898->697; // weight: 0.8889 - 899->688; // weight: 0.2222 - 899->696; // weight: -0.1111 - 899->698; // weight: 0.8889 - 900->688; // weight: -0.1111 - 900->696; // weight: 0.2222 - 900->698; // weight: 0.8889 - 915->672; // weight: 0.04938 - 915->680; // weight: -0.02469 - 915->688; // weight: -0.02469 - 915->696; // weight: 0.01235 - 915->689; // weight: 0.1975 - 915->697; // weight: -0.09877 - 915->682; // weight: 0.1975 - 915->698; // weight: -0.09877 - 915->702; // weight: 0.7901 - 916->672; // weight: -0.02469 - 916->680; // weight: 0.04938 - 916->688; // weight: 0.01235 - 916->696; // weight: -0.02469 - 916->689; // weight: -0.09877 - 916->697; // weight: 0.1975 - 916->682; // weight: 0.1975 - 916->698; // weight: -0.09877 - 916->702; // weight: 0.7901 - 917->672; // weight: -0.02469 - 917->680; // weight: 0.01235 - 917->688; // weight: 0.04938 - 917->696; // weight: -0.02469 - 917->689; // weight: 0.1975 - 917->697; // weight: -0.09877 - 917->682; // weight: -0.09877 - 917->698; // weight: 0.1975 - 917->702; // weight: 0.7901 - 918->672; // weight: 0.01235 - 918->680; // weight: -0.02469 - 918->688; // weight: -0.02469 - 918->696; // weight: 0.04938 - 918->689; // weight: -0.09877 - 918->697; // weight: 0.1975 - 918->682; // weight: -0.09877 - 918->698; // weight: 0.1975 - 918->702; // weight: 0.7901 - 65->452; // weight: 0.2222 - 65->149; // weight: -0.1111 - 65->734; // weight: 0.8889 - 66->452; // weight: -0.1111 - 66->149; // weight: 0.2222 - 66->734; // weight: 0.8889 - 69->2; // weight: 0.04938 - 69->452; // weight: -0.02469 - 69->6; // weight: -0.02469 - 69->149; // weight: 0.01235 - 69->18; // weight: 0.1975 - 69->734; // weight: -0.09877 - 69->453; // weight: 0.1975 - 69->152; // weight: -0.09877 - 69->735; // weight: 0.7901 - 70->2; // weight: -0.02469 - 70->452; // weight: 0.04938 - 70->6; // weight: 0.01235 - 70->149; // weight: -0.02469 - 70->18; // weight: -0.09877 - 70->734; // weight: 0.1975 - 70->453; // weight: 0.1975 - 70->152; // weight: -0.09877 - 70->735; // weight: 0.7901 - 71->2; // weight: -0.02469 - 71->452; // weight: 0.01235 - 71->6; // weight: 0.04938 - 71->149; // weight: -0.02469 - 71->18; // weight: 0.1975 - 71->734; // weight: -0.09877 - 71->453; // weight: -0.09877 - 71->152; // weight: 0.1975 - 71->735; // weight: 0.7901 - 72->2; // weight: 0.01235 - 72->452; // weight: -0.02469 - 72->6; // weight: -0.02469 - 72->149; // weight: 0.04938 - 72->18; // weight: -0.09877 - 72->734; // weight: 0.1975 - 72->453; // weight: -0.09877 - 72->152; // weight: 0.1975 - 72->735; // weight: 0.7901 - 230->174; // weight: 0.04938 - 230->178; // weight: -0.02469 - 230->452; // weight: -0.02469 - 230->149; // weight: 0.01235 - 230->454; // weight: 0.1975 - 230->310; // weight: -0.09877 - 230->190; // weight: 0.1975 - 230->734; // weight: -0.09877 - 230->736; // weight: 0.7901 - 231->174; // weight: -0.02469 - 231->178; // weight: 0.04938 - 231->452; // weight: 0.01235 - 231->149; // weight: -0.02469 - 231->454; // weight: -0.09877 - 231->310; // weight: 0.1975 - 231->190; // weight: 0.1975 - 231->734; // weight: -0.09877 - 231->736; // weight: 0.7901 - 232->174; // weight: -0.02469 - 232->178; // weight: 0.01235 - 232->452; // weight: 0.04938 - 232->149; // weight: -0.02469 - 232->454; // weight: 0.1975 - 232->310; // weight: -0.09877 - 232->190; // weight: -0.09877 - 232->734; // weight: 0.1975 - 232->736; // weight: 0.7901 - 233->174; // weight: 0.01235 - 233->178; // weight: -0.02469 - 233->452; // weight: -0.02469 - 233->149; // weight: 0.04938 - 233->454; // weight: -0.09877 - 233->310; // weight: 0.1975 - 233->190; // weight: -0.09877 - 233->734; // weight: 0.1975 - 233->736; // weight: 0.7901 -} -DEAL:: Number of degrees of freedom: 1073 -DEAL:: Number of constraints : 172 -DEAL:cg::Starting value 0.1494 -DEAL:cg::Convergence step 16 value 1.012e-09 -DEAL::Cycle 3: -DEAL:: Number of active cells: 190 -digraph constraints { - 1019->9; // weight: 1.000 - 1021->17; // weight: 1.000 - 1023->21; // weight: 1.000 - 1033->1; // weight: 0.3750 - 1033->5; // weight: -0.1250 - 1033->17; // weight: 0.7500 - 1035->9; // weight: 0.3750 - 1035->13; // weight: -0.1250 - 1035->21; // weight: 0.7500 - 1025->1; // weight: 0.3750 - 1025->3; // weight: -0.1250 - 1025->9; // weight: 0.7500 - 1029->17; // weight: 0.3750 - 1029->19; // weight: -0.1250 - 1029->21; // weight: 0.7500 - 1037->1; // weight: 0.1406 - 1037->3; // weight: -0.04688 - 1037->5; // weight: -0.04688 - 1037->7; // weight: 0.01562 - 1037->17; // weight: 0.2812 - 1037->19; // weight: -0.09375 - 1037->9; // weight: 0.2812 - 1037->13; // weight: -0.09375 - 1037->21; // weight: 0.5625 - 1062->19; // weight: 1.000 - 1070->3; // weight: 0.3750 - 1070->7; // weight: -0.1250 - 1070->19; // weight: 0.7500 - 1064->1; // weight: -0.1250 - 1064->3; // weight: 0.3750 - 1064->9; // weight: 0.7500 - 1067->17; // weight: -0.1250 - 1067->19; // weight: 0.3750 - 1067->21; // weight: 0.7500 - 1072->1; // weight: -0.04688 - 1072->3; // weight: 0.1406 - 1072->5; // weight: 0.01562 - 1072->7; // weight: -0.04688 - 1072->17; // weight: -0.09375 - 1072->19; // weight: 0.2812 - 1072->9; // weight: 0.2812 - 1072->13; // weight: -0.09375 - 1072->21; // weight: 0.5625 - 1090->13; // weight: 1.000 - 1096->1; // weight: -0.1250 - 1096->5; // weight: 0.3750 - 1096->17; // weight: 0.7500 - 1098->9; // weight: -0.1250 - 1098->13; // weight: 0.3750 - 1098->21; // weight: 0.7500 - 1092->5; // weight: 0.3750 - 1092->7; // weight: -0.1250 - 1092->13; // weight: 0.7500 - 1100->1; // weight: -0.04688 - 1100->3; // weight: 0.01562 - 1100->5; // weight: 0.1406 - 1100->7; // weight: -0.04688 - 1100->17; // weight: 0.2812 - 1100->19; // weight: -0.09375 - 1100->9; // weight: -0.09375 - 1100->13; // weight: 0.2812 - 1100->21; // weight: 0.5625 - 1122->3; // weight: -0.1250 - 1122->7; // weight: 0.3750 - 1122->19; // weight: 0.7500 - 1119->5; // weight: -0.1250 - 1119->7; // weight: 0.3750 - 1119->13; // weight: 0.7500 - 1124->1; // weight: 0.01562 - 1124->3; // weight: -0.04688 - 1124->5; // weight: -0.04688 - 1124->7; // weight: 0.1406 - 1124->17; // weight: -0.09375 - 1124->19; // weight: 0.2812 - 1124->9; // weight: -0.09375 - 1124->13; // weight: 0.2812 - 1124->21; // weight: 0.5625 - 33->2; // weight: 0.3750 - 33->3; // weight: -0.1250 - 33->11; // weight: 0.7500 - 34->11; // weight: 1.000 - 35->2; // weight: -0.1250 - 35->3; // weight: 0.3750 - 35->11; // weight: 0.7500 - 45->6; // weight: 0.3750 - 45->7; // weight: -0.1250 - 45->15; // weight: 0.7500 - 46->15; // weight: 1.000 - 47->6; // weight: -0.1250 - 47->7; // weight: 0.3750 - 47->15; // weight: 0.7500 - 51->2; // weight: 0.3750 - 51->6; // weight: -0.1250 - 51->18; // weight: 0.7500 - 52->18; // weight: 1.000 - 53->2; // weight: -0.1250 - 53->6; // weight: 0.3750 - 53->18; // weight: 0.7500 - 54->3; // weight: 0.3750 - 54->7; // weight: -0.1250 - 54->19; // weight: 0.7500 - 55->19; // weight: 1.000 - 56->3; // weight: -0.1250 - 56->7; // weight: 0.3750 - 56->19; // weight: 0.7500 - 80->2; // weight: 0.1406 - 80->6; // weight: -0.04688 - 80->3; // weight: -0.04688 - 80->7; // weight: 0.01562 - 80->11; // weight: 0.2812 - 80->15; // weight: -0.09375 - 80->18; // weight: 0.2812 - 80->19; // weight: -0.09375 - 80->23; // weight: 0.5625 - 81->18; // weight: 0.3750 - 81->19; // weight: -0.1250 - 81->23; // weight: 0.7500 - 82->2; // weight: -0.04688 - 82->6; // weight: 0.1406 - 82->3; // weight: 0.01562 - 82->7; // weight: -0.04688 - 82->11; // weight: -0.09375 - 82->15; // weight: 0.2812 - 82->18; // weight: 0.2812 - 82->19; // weight: -0.09375 - 82->23; // weight: 0.5625 - 83->11; // weight: 0.3750 - 83->15; // weight: -0.1250 - 83->23; // weight: 0.7500 - 84->11; // weight: -0.1250 - 84->15; // weight: 0.3750 - 84->23; // weight: 0.7500 - 85->2; // weight: -0.04688 - 85->6; // weight: 0.01562 - 85->3; // weight: 0.1406 - 85->7; // weight: -0.04688 - 85->11; // weight: 0.2812 - 85->15; // weight: -0.09375 - 85->18; // weight: -0.09375 - 85->19; // weight: 0.2812 - 85->23; // weight: 0.5625 - 86->18; // weight: -0.1250 - 86->19; // weight: 0.3750 - 86->23; // weight: 0.7500 - 87->2; // weight: 0.01562 - 87->6; // weight: -0.04688 - 87->3; // weight: -0.04688 - 87->7; // weight: 0.1406 - 87->11; // weight: -0.09375 - 87->15; // weight: 0.2812 - 87->18; // weight: -0.09375 - 87->19; // weight: 0.2812 - 87->23; // weight: 0.5625 - 1235->14; // weight: 1.000 - 1236->12; // weight: 1.000 - 1237->25; // weight: 1.000 - 1242->4; // weight: 0.3750 - 1242->6; // weight: -0.1250 - 1242->12; // weight: 0.7500 - 1243->14; // weight: 0.3750 - 1243->15; // weight: -0.1250 - 1243->25; // weight: 0.7500 - 1244->4; // weight: 0.3750 - 1244->5; // weight: -0.1250 - 1244->14; // weight: 0.7500 - 1245->12; // weight: 0.3750 - 1245->13; // weight: -0.1250 - 1245->25; // weight: 0.7500 - 1258->4; // weight: 0.1406 - 1258->5; // weight: -0.04688 - 1258->6; // weight: -0.04688 - 1258->7; // weight: 0.01562 - 1258->12; // weight: 0.2812 - 1258->13; // weight: -0.09375 - 1258->14; // weight: 0.2812 - 1258->15; // weight: -0.09375 - 1258->25; // weight: 0.5625 - 1263->4; // weight: -0.1250 - 1263->5; // weight: 0.3750 - 1263->14; // weight: 0.7500 - 1264->12; // weight: -0.1250 - 1264->13; // weight: 0.3750 - 1264->25; // weight: 0.7500 - 1273->4; // weight: -0.04688 - 1273->5; // weight: 0.1406 - 1273->6; // weight: 0.01562 - 1273->7; // weight: -0.04688 - 1273->12; // weight: -0.09375 - 1273->13; // weight: 0.2812 - 1273->14; // weight: 0.2812 - 1273->15; // weight: -0.09375 - 1273->25; // weight: 0.5625 - 1276->15; // weight: 1.000 - 1279->4; // weight: -0.1250 - 1279->6; // weight: 0.3750 - 1279->12; // weight: 0.7500 - 1280->14; // weight: -0.1250 - 1280->15; // weight: 0.3750 - 1280->25; // weight: 0.7500 - 1281->6; // weight: 0.3750 - 1281->7; // weight: -0.1250 - 1281->15; // weight: 0.7500 - 1290->4; // weight: -0.04688 - 1290->5; // weight: 0.01562 - 1290->6; // weight: 0.1406 - 1290->7; // weight: -0.04688 - 1290->12; // weight: 0.2812 - 1290->13; // weight: -0.09375 - 1290->14; // weight: -0.09375 - 1290->15; // weight: 0.2812 - 1290->25; // weight: 0.5625 - 1294->6; // weight: -0.1250 - 1294->7; // weight: 0.3750 - 1294->15; // weight: 0.7500 - 1300->4; // weight: 0.01562 - 1300->5; // weight: -0.04688 - 1300->6; // weight: -0.04688 - 1300->7; // weight: 0.1406 - 1300->12; // weight: -0.09375 - 1300->13; // weight: 0.2812 - 1300->14; // weight: -0.09375 - 1300->15; // weight: 0.2812 - 1300->25; // weight: 0.5625 - 61->476; // weight: -0.5000 - 61->1215; // weight: 0.1667 - 61->60; // weight: 1.333 - 62->476; // weight: -0.5000 - 62->1215; // weight: 0.5000 - 62->60; // weight: 1.000 - 31->3; // weight: -0.5000 - 31->476; // weight: 0.1667 - 31->30; // weight: 1.333 - 32->3; // weight: -0.5000 - 32->476; // weight: 0.5000 - 32->30; // weight: 1.000 - 43->7; // weight: -0.5000 - 43->1215; // weight: 0.1667 - 43->42; // weight: 1.333 - 44->7; // weight: -0.5000 - 44->1215; // weight: 0.5000 - 44->42; // weight: 1.000 - 72->54; // weight: -0.5000 - 72->60; // weight: 0.1667 - 72->71; // weight: 1.333 - 73->54; // weight: -0.5000 - 73->60; // weight: 0.5000 - 73->71; // weight: 1.000 - 74->30; // weight: -0.5000 - 74->42; // weight: 0.1667 - 74->71; // weight: 1.333 - 75->3; // weight: 0.2500 - 75->476; // weight: -0.08333 - 75->7; // weight: -0.08333 - 75->1215; // weight: 0.02778 - 75->54; // weight: -0.6667 - 75->60; // weight: 0.2222 - 75->30; // weight: -0.6667 - 75->42; // weight: 0.2222 - 75->71; // weight: 1.778 - 76->3; // weight: 0.2500 - 76->476; // weight: -0.2500 - 76->7; // weight: -0.08333 - 76->1215; // weight: 0.08333 - 76->54; // weight: -0.6667 - 76->60; // weight: 0.6667 - 76->30; // weight: -0.5000 - 76->42; // weight: 0.1667 - 76->71; // weight: 1.333 - 77->30; // weight: -0.5000 - 77->42; // weight: 0.5000 - 77->71; // weight: 1.000 - 78->3; // weight: 0.2500 - 78->476; // weight: -0.08333 - 78->7; // weight: -0.2500 - 78->1215; // weight: 0.08333 - 78->54; // weight: -0.5000 - 78->60; // weight: 0.1667 - 78->30; // weight: -0.6667 - 78->42; // weight: 0.6667 - 78->71; // weight: 1.333 - 79->3; // weight: 0.2500 - 79->476; // weight: -0.2500 - 79->7; // weight: -0.2500 - 79->1215; // weight: 0.2500 - 79->54; // weight: -0.5000 - 79->60; // weight: 0.5000 - 79->30; // weight: -0.5000 - 79->42; // weight: 0.5000 - 79->71; // weight: 1.000 - 1137->3; // weight: -0.5000 - 1137->476; // weight: 0.1667 - 1137->30; // weight: 1.333 - 1139->3; // weight: 0.2500 - 1139->476; // weight: -0.08333 - 1139->7; // weight: -0.08333 - 1139->1215; // weight: 0.02778 - 1139->54; // weight: -0.6667 - 1139->60; // weight: 0.2222 - 1139->30; // weight: -0.6667 - 1139->42; // weight: 0.2222 - 1139->71; // weight: 1.778 - 1147->54; // weight: -0.5000 - 1147->60; // weight: 0.1667 - 1147->71; // weight: 1.333 - 1141->30; // weight: 1.000 - 1144->30; // weight: -0.5000 - 1144->42; // weight: 0.1667 - 1144->71; // weight: 1.333 - 1149->71; // weight: 1.000 - 1168->476; // weight: -0.5000 - 1168->1215; // weight: 0.1667 - 1168->60; // weight: 1.333 - 1176->60; // weight: 1.000 - 1170->3; // weight: -0.5000 - 1170->476; // weight: 0.5000 - 1170->30; // weight: 1.000 - 1173->3; // weight: 0.2500 - 1173->476; // weight: -0.2500 - 1173->7; // weight: -0.08333 - 1173->1215; // weight: 0.08333 - 1173->54; // weight: -0.6667 - 1173->60; // weight: 0.6667 - 1173->30; // weight: -0.5000 - 1173->42; // weight: 0.1667 - 1173->71; // weight: 1.333 - 1178->54; // weight: -0.5000 - 1178->60; // weight: 0.5000 - 1178->71; // weight: 1.000 - 1195->7; // weight: -0.5000 - 1195->1215; // weight: 0.1667 - 1195->42; // weight: 1.333 - 1200->3; // weight: 0.2500 - 1200->476; // weight: -0.08333 - 1200->7; // weight: -0.2500 - 1200->1215; // weight: 0.08333 - 1200->54; // weight: -0.5000 - 1200->60; // weight: 0.1667 - 1200->30; // weight: -0.6667 - 1200->42; // weight: 0.6667 - 1200->71; // weight: 1.333 - 1197->42; // weight: 1.000 - 1202->30; // weight: -0.5000 - 1202->42; // weight: 0.5000 - 1202->71; // weight: 1.000 - 1220->476; // weight: -0.5000 - 1220->1215; // weight: 0.5000 - 1220->60; // weight: 1.000 - 1217->7; // weight: -0.5000 - 1217->1215; // weight: 0.5000 - 1217->42; // weight: 1.000 - 1222->3; // weight: 0.2500 - 1222->476; // weight: -0.2500 - 1222->7; // weight: -0.2500 - 1222->1215; // weight: 0.2500 - 1222->54; // weight: -0.5000 - 1222->60; // weight: 0.5000 - 1222->30; // weight: -0.5000 - 1222->42; // weight: 0.5000 - 1222->71; // weight: 1.000 - 40->6; // weight: -0.5000 - 40->636; // weight: 0.1667 - 40->39; // weight: 1.333 - 41->6; // weight: -0.5000 - 41->636; // weight: 0.5000 - 41->39; // weight: 1.000 - 49->636; // weight: -0.5000 - 49->1215; // weight: 0.1667 - 49->48; // weight: 1.333 - 50->636; // weight: -0.5000 - 50->1215; // weight: 0.5000 - 50->48; // weight: 1.000 - 106->39; // weight: -0.5000 - 106->42; // weight: 0.1667 - 106->105; // weight: 1.333 - 107->39; // weight: -0.5000 - 107->42; // weight: 0.5000 - 107->105; // weight: 1.000 - 108->45; // weight: -0.5000 - 108->48; // weight: 0.1667 - 108->105; // weight: 1.333 - 109->6; // weight: 0.2500 - 109->7; // weight: -0.08333 - 109->636; // weight: -0.08333 - 109->1215; // weight: 0.02778 - 109->39; // weight: -0.6667 - 109->42; // weight: 0.2222 - 109->45; // weight: -0.6667 - 109->48; // weight: 0.2222 - 109->105; // weight: 1.778 - 110->6; // weight: 0.2500 - 110->7; // weight: -0.2500 - 110->636; // weight: -0.08333 - 110->1215; // weight: 0.08333 - 110->39; // weight: -0.6667 - 110->42; // weight: 0.6667 - 110->45; // weight: -0.5000 - 110->48; // weight: 0.1667 - 110->105; // weight: 1.333 - 111->45; // weight: -0.5000 - 111->48; // weight: 0.5000 - 111->105; // weight: 1.000 - 112->6; // weight: 0.2500 - 112->7; // weight: -0.08333 - 112->636; // weight: -0.2500 - 112->1215; // weight: 0.08333 - 112->39; // weight: -0.5000 - 112->42; // weight: 0.1667 - 112->45; // weight: -0.6667 - 112->48; // weight: 0.6667 - 112->105; // weight: 1.333 - 113->6; // weight: 0.2500 - 113->7; // weight: -0.2500 - 113->636; // weight: -0.2500 - 113->1215; // weight: 0.2500 - 113->39; // weight: -0.5000 - 113->42; // weight: 0.5000 - 113->45; // weight: -0.5000 - 113->48; // weight: 0.5000 - 113->105; // weight: 1.000 - 1431->6; // weight: -0.5000 - 1431->636; // weight: 0.1667 - 1431->39; // weight: 1.333 - 1432->6; // weight: 0.2500 - 1432->7; // weight: -0.08333 - 1432->636; // weight: -0.08333 - 1432->1215; // weight: 0.02778 - 1432->39; // weight: -0.6667 - 1432->42; // weight: 0.2222 - 1432->45; // weight: -0.6667 - 1432->48; // weight: 0.2222 - 1432->105; // weight: 1.778 - 1435->39; // weight: 1.000 - 1436->39; // weight: -0.5000 - 1436->42; // weight: 0.1667 - 1436->105; // weight: 1.333 - 1437->45; // weight: -0.5000 - 1437->48; // weight: 0.1667 - 1437->105; // weight: 1.333 - 1446->105; // weight: 1.000 - 1450->6; // weight: 0.2500 - 1450->7; // weight: -0.2500 - 1450->636; // weight: -0.08333 - 1450->1215; // weight: 0.08333 - 1450->39; // weight: -0.6667 - 1450->42; // weight: 0.6667 - 1450->45; // weight: -0.5000 - 1450->48; // weight: 0.1667 - 1450->105; // weight: 1.333 - 1456->39; // weight: -0.5000 - 1456->42; // weight: 0.5000 - 1456->105; // weight: 1.000 - 1459->636; // weight: -0.5000 - 1459->1215; // weight: 0.1667 - 1459->48; // weight: 1.333 - 1462->6; // weight: -0.5000 - 1462->636; // weight: 0.5000 - 1462->39; // weight: 1.000 - 1463->6; // weight: 0.2500 - 1463->7; // weight: -0.08333 - 1463->636; // weight: -0.2500 - 1463->1215; // weight: 0.08333 - 1463->39; // weight: -0.5000 - 1463->42; // weight: 0.1667 - 1463->45; // weight: -0.6667 - 1463->48; // weight: 0.6667 - 1463->105; // weight: 1.333 - 1464->48; // weight: 1.000 - 1473->45; // weight: -0.5000 - 1473->48; // weight: 0.5000 - 1473->105; // weight: 1.000 - 1477->636; // weight: -0.5000 - 1477->1215; // weight: 0.5000 - 1477->48; // weight: 1.000 - 1483->6; // weight: 0.2500 - 1483->7; // weight: -0.2500 - 1483->636; // weight: -0.2500 - 1483->1215; // weight: 0.2500 - 1483->39; // weight: -0.5000 - 1483->42; // weight: 0.5000 - 1483->45; // weight: -0.5000 - 1483->48; // weight: 0.5000 - 1483->105; // weight: 1.000 - 192->142; // weight: 0.3750 - 192->146; // weight: -0.1250 - 192->158; // weight: 0.7500 - 193->158; // weight: 1.000 - 194->142; // weight: -0.1250 - 194->146; // weight: 0.3750 - 194->158; // weight: 0.7500 - 195->144; // weight: 0.3750 - 195->148; // weight: -0.1250 - 195->160; // weight: 0.7500 - 196->160; // weight: 1.000 - 197->144; // weight: -0.1250 - 197->148; // weight: 0.3750 - 197->160; // weight: 0.7500 - 168->142; // weight: 0.3750 - 168->144; // weight: -0.1250 - 168->150; // weight: 0.7500 - 169->150; // weight: 1.000 - 170->142; // weight: -0.1250 - 170->144; // weight: 0.3750 - 170->150; // weight: 0.7500 - 180->146; // weight: 0.3750 - 180->148; // weight: -0.1250 - 180->154; // weight: 0.7500 - 181->154; // weight: 1.000 - 182->146; // weight: -0.1250 - 182->148; // weight: 0.3750 - 182->154; // weight: 0.7500 - 201->142; // weight: 0.1406 - 201->144; // weight: -0.04688 - 201->146; // weight: -0.04688 - 201->148; // weight: 0.01562 - 201->158; // weight: 0.2812 - 201->160; // weight: -0.09375 - 201->150; // weight: 0.2812 - 201->154; // weight: -0.09375 - 201->162; // weight: 0.5625 - 202->150; // weight: 0.3750 - 202->154; // weight: -0.1250 - 202->162; // weight: 0.7500 - 203->142; // weight: -0.04688 - 203->144; // weight: 0.1406 - 203->146; // weight: 0.01562 - 203->148; // weight: -0.04688 - 203->158; // weight: -0.09375 - 203->160; // weight: 0.2812 - 203->150; // weight: 0.2812 - 203->154; // weight: -0.09375 - 203->162; // weight: 0.5625 - 204->158; // weight: 0.3750 - 204->160; // weight: -0.1250 - 204->162; // weight: 0.7500 - 205->158; // weight: -0.1250 - 205->160; // weight: 0.3750 - 205->162; // weight: 0.7500 - 206->142; // weight: -0.04688 - 206->144; // weight: 0.01562 - 206->146; // weight: 0.1406 - 206->148; // weight: -0.04688 - 206->158; // weight: 0.2812 - 206->160; // weight: -0.09375 - 206->150; // weight: -0.09375 - 206->154; // weight: 0.2812 - 206->162; // weight: 0.5625 - 207->150; // weight: -0.1250 - 207->154; // weight: 0.3750 - 207->162; // weight: 0.7500 - 208->142; // weight: 0.01562 - 208->144; // weight: -0.04688 - 208->146; // weight: -0.04688 - 208->148; // weight: 0.1406 - 208->158; // weight: -0.09375 - 208->160; // weight: 0.2812 - 208->150; // weight: -0.09375 - 208->154; // weight: 0.2812 - 208->162; // weight: 0.5625 - 1592->159; // weight: 1.000 - 1589->152; // weight: 1.000 - 1593->164; // weight: 1.000 - 1598->143; // weight: 0.3750 - 1598->144; // weight: -0.1250 - 1598->152; // weight: 0.7500 - 1602->159; // weight: 0.3750 - 1602->160; // weight: -0.1250 - 1602->164; // weight: 0.7500 - 1604->143; // weight: 0.3750 - 1604->147; // weight: -0.1250 - 1604->159; // weight: 0.7500 - 1605->152; // weight: 0.3750 - 1605->156; // weight: -0.1250 - 1605->164; // weight: 0.7500 - 1610->143; // weight: 0.1406 - 1610->147; // weight: -0.04688 - 1610->144; // weight: -0.04688 - 1610->148; // weight: 0.01562 - 1610->152; // weight: 0.2812 - 1610->156; // weight: -0.09375 - 1610->159; // weight: 0.2812 - 1610->160; // weight: -0.09375 - 1610->164; // weight: 0.5625 - 1660->156; // weight: 1.000 - 1665->147; // weight: 0.3750 - 1665->148; // weight: -0.1250 - 1665->156; // weight: 0.7500 - 1667->143; // weight: -0.1250 - 1667->147; // weight: 0.3750 - 1667->159; // weight: 0.7500 - 1668->152; // weight: -0.1250 - 1668->156; // weight: 0.3750 - 1668->164; // weight: 0.7500 - 1673->143; // weight: -0.04688 - 1673->147; // weight: 0.1406 - 1673->144; // weight: 0.01562 - 1673->148; // weight: -0.04688 - 1673->152; // weight: -0.09375 - 1673->156; // weight: 0.2812 - 1673->159; // weight: 0.2812 - 1673->160; // weight: -0.09375 - 1673->164; // weight: 0.5625 - 1616->160; // weight: 1.000 - 1619->143; // weight: -0.1250 - 1619->144; // weight: 0.3750 - 1619->152; // weight: 0.7500 - 1622->159; // weight: -0.1250 - 1622->160; // weight: 0.3750 - 1622->164; // weight: 0.7500 - 1624->144; // weight: 0.3750 - 1624->148; // weight: -0.1250 - 1624->160; // weight: 0.7500 - 1627->143; // weight: -0.04688 - 1627->147; // weight: 0.01562 - 1627->144; // weight: 0.1406 - 1627->148; // weight: -0.04688 - 1627->152; // weight: 0.2812 - 1627->156; // weight: -0.09375 - 1627->159; // weight: -0.09375 - 1627->160; // weight: 0.2812 - 1627->164; // weight: 0.5625 - 1679->147; // weight: -0.1250 - 1679->148; // weight: 0.3750 - 1679->156; // weight: 0.7500 - 1681->144; // weight: -0.1250 - 1681->148; // weight: 0.3750 - 1681->160; // weight: 0.7500 - 1684->143; // weight: 0.01562 - 1684->147; // weight: -0.04688 - 1684->144; // weight: -0.04688 - 1684->148; // weight: 0.1406 - 1684->152; // weight: -0.09375 - 1684->156; // weight: 0.2812 - 1684->159; // weight: -0.09375 - 1684->160; // weight: 0.2812 - 1684->164; // weight: 0.5625 - 1806->155; // weight: 1.000 - 1807->153; // weight: 1.000 - 1808->166; // weight: 1.000 - 1813->145; // weight: 0.3750 - 1813->147; // weight: -0.1250 - 1813->153; // weight: 0.7500 - 1814->155; // weight: 0.3750 - 1814->156; // weight: -0.1250 - 1814->166; // weight: 0.7500 - 1815->145; // weight: 0.3750 - 1815->146; // weight: -0.1250 - 1815->155; // weight: 0.7500 - 1816->153; // weight: 0.3750 - 1816->154; // weight: -0.1250 - 1816->166; // weight: 0.7500 - 1829->145; // weight: 0.1406 - 1829->146; // weight: -0.04688 - 1829->147; // weight: -0.04688 - 1829->148; // weight: 0.01562 - 1829->153; // weight: 0.2812 - 1829->154; // weight: -0.09375 - 1829->155; // weight: 0.2812 - 1829->156; // weight: -0.09375 - 1829->166; // weight: 0.5625 - 1832->154; // weight: 1.000 - 1835->146; // weight: 0.3750 - 1835->148; // weight: -0.1250 - 1835->154; // weight: 0.7500 - 1836->145; // weight: -0.1250 - 1836->146; // weight: 0.3750 - 1836->155; // weight: 0.7500 - 1837->153; // weight: -0.1250 - 1837->154; // weight: 0.3750 - 1837->166; // weight: 0.7500 - 1846->145; // weight: -0.04688 - 1846->146; // weight: 0.1406 - 1846->147; // weight: 0.01562 - 1846->148; // weight: -0.04688 - 1846->153; // weight: -0.09375 - 1846->154; // weight: 0.2812 - 1846->155; // weight: 0.2812 - 1846->156; // weight: -0.09375 - 1846->166; // weight: 0.5625 - 1851->145; // weight: -0.1250 - 1851->147; // weight: 0.3750 - 1851->153; // weight: 0.7500 - 1852->155; // weight: -0.1250 - 1852->156; // weight: 0.3750 - 1852->166; // weight: 0.7500 - 1861->145; // weight: -0.04688 - 1861->146; // weight: 0.01562 - 1861->147; // weight: 0.1406 - 1861->148; // weight: -0.04688 - 1861->153; // weight: 0.2812 - 1861->154; // weight: -0.09375 - 1861->155; // weight: -0.09375 - 1861->156; // weight: 0.2812 - 1861->166; // weight: 0.5625 - 1865->146; // weight: -0.1250 - 1865->148; // weight: 0.3750 - 1865->154; // weight: 0.7500 - 1871->145; // weight: 0.01562 - 1871->146; // weight: -0.04688 - 1871->147; // weight: -0.04688 - 1871->148; // weight: 0.1406 - 1871->153; // weight: -0.09375 - 1871->154; // weight: 0.2812 - 1871->155; // weight: -0.09375 - 1871->156; // weight: 0.2812 - 1871->166; // weight: 0.5625 - 178->144; // weight: -0.5000 - 178->558; // weight: 0.1667 - 178->177; // weight: 1.333 - 179->144; // weight: -0.5000 - 179->558; // weight: 0.5000 - 179->177; // weight: 1.000 - 190->148; // weight: -0.5000 - 190->1778; // weight: 0.1667 - 190->189; // weight: 1.333 - 191->148; // weight: -0.5000 - 191->1778; // weight: 0.5000 - 191->189; // weight: 1.000 - 199->558; // weight: -0.5000 - 199->1778; // weight: 0.1667 - 199->198; // weight: 1.333 - 200->558; // weight: -0.5000 - 200->1778; // weight: 0.5000 - 200->198; // weight: 1.000 - 227->177; // weight: -0.5000 - 227->189; // weight: 0.1667 - 227->226; // weight: 1.333 - 228->177; // weight: -0.5000 - 228->189; // weight: 0.5000 - 228->226; // weight: 1.000 - 229->195; // weight: -0.5000 - 229->198; // weight: 0.1667 - 229->226; // weight: 1.333 - 230->144; // weight: 0.2500 - 230->148; // weight: -0.08333 - 230->558; // weight: -0.08333 - 230->1778; // weight: 0.02778 - 230->177; // weight: -0.6667 - 230->189; // weight: 0.2222 - 230->195; // weight: -0.6667 - 230->198; // weight: 0.2222 - 230->226; // weight: 1.778 - 231->144; // weight: 0.2500 - 231->148; // weight: -0.2500 - 231->558; // weight: -0.08333 - 231->1778; // weight: 0.08333 - 231->177; // weight: -0.6667 - 231->189; // weight: 0.6667 - 231->195; // weight: -0.5000 - 231->198; // weight: 0.1667 - 231->226; // weight: 1.333 - 232->195; // weight: -0.5000 - 232->198; // weight: 0.5000 - 232->226; // weight: 1.000 - 233->144; // weight: 0.2500 - 233->148; // weight: -0.08333 - 233->558; // weight: -0.2500 - 233->1778; // weight: 0.08333 - 233->177; // weight: -0.5000 - 233->189; // weight: 0.1667 - 233->195; // weight: -0.6667 - 233->198; // weight: 0.6667 - 233->226; // weight: 1.333 - 234->144; // weight: 0.2500 - 234->148; // weight: -0.2500 - 234->558; // weight: -0.2500 - 234->1778; // weight: 0.2500 - 234->177; // weight: -0.5000 - 234->189; // weight: 0.5000 - 234->195; // weight: -0.5000 - 234->198; // weight: 0.5000 - 234->226; // weight: 1.000 - 1708->144; // weight: -0.5000 - 1708->558; // weight: 0.1667 - 1708->177; // weight: 1.333 - 1710->144; // weight: 0.2500 - 1710->148; // weight: -0.08333 - 1710->558; // weight: -0.08333 - 1710->1778; // weight: 0.02778 - 1710->177; // weight: -0.6667 - 1710->189; // weight: 0.2222 - 1710->195; // weight: -0.6667 - 1710->198; // weight: 0.2222 - 1710->226; // weight: 1.778 - 1713->177; // weight: 1.000 - 1716->177; // weight: -0.5000 - 1716->189; // weight: 0.1667 - 1716->226; // weight: 1.333 - 1718->195; // weight: -0.5000 - 1718->198; // weight: 0.1667 - 1718->226; // weight: 1.333 - 1721->226; // weight: 1.000 - 1766->148; // weight: -0.5000 - 1766->1778; // weight: 0.1667 - 1766->189; // weight: 1.333 - 1769->189; // weight: 1.000 - 1771->144; // weight: 0.2500 - 1771->148; // weight: -0.2500 - 1771->558; // weight: -0.08333 - 1771->1778; // weight: 0.08333 - 1771->177; // weight: -0.6667 - 1771->189; // weight: 0.6667 - 1771->195; // weight: -0.5000 - 1771->198; // weight: 0.1667 - 1771->226; // weight: 1.333 - 1774->177; // weight: -0.5000 - 1774->189; // weight: 0.5000 - 1774->226; // weight: 1.000 - 1727->558; // weight: -0.5000 - 1727->1778; // weight: 0.1667 - 1727->198; // weight: 1.333 - 1730->144; // weight: -0.5000 - 1730->558; // weight: 0.5000 - 1730->177; // weight: 1.000 - 1733->144; // weight: 0.2500 - 1733->148; // weight: -0.08333 - 1733->558; // weight: -0.2500 - 1733->1778; // weight: 0.08333 - 1733->177; // weight: -0.5000 - 1733->189; // weight: 0.1667 - 1733->195; // weight: -0.6667 - 1733->198; // weight: 0.6667 - 1733->226; // weight: 1.333 - 1735->198; // weight: 1.000 - 1738->195; // weight: -0.5000 - 1738->198; // weight: 0.5000 - 1738->226; // weight: 1.000 - 1781->148; // weight: -0.5000 - 1781->1778; // weight: 0.5000 - 1781->189; // weight: 1.000 - 1783->558; // weight: -0.5000 - 1783->1778; // weight: 0.5000 - 1783->198; // weight: 1.000 - 1786->144; // weight: 0.2500 - 1786->148; // weight: -0.2500 - 1786->558; // weight: -0.2500 - 1786->1778; // weight: 0.2500 - 1786->177; // weight: -0.5000 - 1786->189; // weight: 0.5000 - 1786->195; // weight: -0.5000 - 1786->198; // weight: 0.5000 - 1786->226; // weight: 1.000 - 184->636; // weight: -0.5000 - 184->1778; // weight: 0.1667 - 184->183; // weight: 1.333 - 185->636; // weight: -0.5000 - 185->1778; // weight: 0.5000 - 185->183; // weight: 1.000 - 187->146; // weight: -0.5000 - 187->636; // weight: 0.1667 - 187->186; // weight: 1.333 - 188->146; // weight: -0.5000 - 188->636; // weight: 0.5000 - 188->186; // weight: 1.000 - 244->180; // weight: -0.5000 - 244->183; // weight: 0.1667 - 244->243; // weight: 1.333 - 245->180; // weight: -0.5000 - 245->183; // weight: 0.5000 - 245->243; // weight: 1.000 - 246->186; // weight: -0.5000 - 246->189; // weight: 0.1667 - 246->243; // weight: 1.333 - 247->146; // weight: 0.2500 - 247->636; // weight: -0.08333 - 247->148; // weight: -0.08333 - 247->1778; // weight: 0.02778 - 247->180; // weight: -0.6667 - 247->183; // weight: 0.2222 - 247->186; // weight: -0.6667 - 247->189; // weight: 0.2222 - 247->243; // weight: 1.778 - 248->146; // weight: 0.2500 - 248->636; // weight: -0.2500 - 248->148; // weight: -0.08333 - 248->1778; // weight: 0.08333 - 248->180; // weight: -0.6667 - 248->183; // weight: 0.6667 - 248->186; // weight: -0.5000 - 248->189; // weight: 0.1667 - 248->243; // weight: 1.333 - 249->186; // weight: -0.5000 - 249->189; // weight: 0.5000 - 249->243; // weight: 1.000 - 250->146; // weight: 0.2500 - 250->636; // weight: -0.08333 - 250->148; // weight: -0.2500 - 250->1778; // weight: 0.08333 - 250->180; // weight: -0.5000 - 250->183; // weight: 0.1667 - 250->186; // weight: -0.6667 - 250->189; // weight: 0.6667 - 250->243; // weight: 1.333 - 251->146; // weight: 0.2500 - 251->636; // weight: -0.2500 - 251->148; // weight: -0.2500 - 251->1778; // weight: 0.2500 - 251->180; // weight: -0.5000 - 251->183; // weight: 0.5000 - 251->186; // weight: -0.5000 - 251->189; // weight: 0.5000 - 251->243; // weight: 1.000 - 1922->146; // weight: -0.5000 - 1922->636; // weight: 0.1667 - 1922->186; // weight: 1.333 - 1923->146; // weight: 0.2500 - 1923->636; // weight: -0.08333 - 1923->148; // weight: -0.08333 - 1923->1778; // weight: 0.02778 - 1923->180; // weight: -0.6667 - 1923->183; // weight: 0.2222 - 1923->186; // weight: -0.6667 - 1923->189; // weight: 0.2222 - 1923->243; // weight: 1.778 - 1926->180; // weight: -0.5000 - 1926->183; // weight: 0.1667 - 1926->243; // weight: 1.333 - 1927->186; // weight: 1.000 - 1928->186; // weight: -0.5000 - 1928->189; // weight: 0.1667 - 1928->243; // weight: 1.333 - 1937->243; // weight: 1.000 - 1940->636; // weight: -0.5000 - 1940->1778; // weight: 0.1667 - 1940->183; // weight: 1.333 - 1942->183; // weight: 1.000 - 1943->146; // weight: -0.5000 - 1943->636; // weight: 0.5000 - 1943->186; // weight: 1.000 - 1944->146; // weight: 0.2500 - 1944->636; // weight: -0.2500 - 1944->148; // weight: -0.08333 - 1944->1778; // weight: 0.08333 - 1944->180; // weight: -0.6667 - 1944->183; // weight: 0.6667 - 1944->186; // weight: -0.5000 - 1944->189; // weight: 0.1667 - 1944->243; // weight: 1.333 - 1952->180; // weight: -0.5000 - 1952->183; // weight: 0.5000 - 1952->243; // weight: 1.000 - 1956->146; // weight: 0.2500 - 1956->636; // weight: -0.08333 - 1956->148; // weight: -0.2500 - 1956->1778; // weight: 0.08333 - 1956->180; // weight: -0.5000 - 1956->183; // weight: 0.1667 - 1956->186; // weight: -0.6667 - 1956->189; // weight: 0.6667 - 1956->243; // weight: 1.333 - 1962->186; // weight: -0.5000 - 1962->189; // weight: 0.5000 - 1962->243; // weight: 1.000 - 1966->636; // weight: -0.5000 - 1966->1778; // weight: 0.5000 - 1966->183; // weight: 1.000 - 1972->146; // weight: 0.2500 - 1972->636; // weight: -0.2500 - 1972->148; // weight: -0.2500 - 1972->1778; // weight: 0.2500 - 1972->180; // weight: -0.5000 - 1972->183; // weight: 0.5000 - 1972->186; // weight: -0.5000 - 1972->189; // weight: 0.5000 - 1972->243; // weight: 1.000 - 2160->440; // weight: 1.000 - 2157->449; // weight: 1.000 - 2161->454; // weight: 1.000 - 2166->434; // weight: 0.3750 - 2166->446; // weight: -0.1250 - 2166->449; // weight: 0.7500 - 2170->440; // weight: 0.3750 - 2170->452; // weight: -0.1250 - 2170->454; // weight: 0.7500 - 2172->434; // weight: 0.3750 - 2172->435; // weight: -0.1250 - 2172->440; // weight: 0.7500 - 2173->449; // weight: 0.3750 - 2173->451; // weight: -0.1250 - 2173->454; // weight: 0.7500 - 2178->434; // weight: 0.1406 - 2178->435; // weight: -0.04688 - 2178->446; // weight: -0.04688 - 2178->447; // weight: 0.01562 - 2178->449; // weight: 0.2812 - 2178->451; // weight: -0.09375 - 2178->440; // weight: 0.2812 - 2178->452; // weight: -0.09375 - 2178->454; // weight: 0.5625 - 2229->451; // weight: 1.000 - 2234->435; // weight: 0.3750 - 2234->447; // weight: -0.1250 - 2234->451; // weight: 0.7500 - 2236->434; // weight: -0.1250 - 2236->435; // weight: 0.3750 - 2236->440; // weight: 0.7500 - 2237->449; // weight: -0.1250 - 2237->451; // weight: 0.3750 - 2237->454; // weight: 0.7500 - 2242->434; // weight: -0.04688 - 2242->435; // weight: 0.1406 - 2242->446; // weight: 0.01562 - 2242->447; // weight: -0.04688 - 2242->449; // weight: -0.09375 - 2242->451; // weight: 0.2812 - 2242->440; // weight: 0.2812 - 2242->452; // weight: -0.09375 - 2242->454; // weight: 0.5625 - 2184->452; // weight: 1.000 - 2187->434; // weight: -0.1250 - 2187->446; // weight: 0.3750 - 2187->449; // weight: 0.7500 - 2190->440; // weight: -0.1250 - 2190->452; // weight: 0.3750 - 2190->454; // weight: 0.7500 - 2192->446; // weight: 0.3750 - 2192->447; // weight: -0.1250 - 2192->452; // weight: 0.7500 - 2195->434; // weight: -0.04688 - 2195->435; // weight: 0.01562 - 2195->446; // weight: 0.1406 - 2195->447; // weight: -0.04688 - 2195->449; // weight: 0.2812 - 2195->451; // weight: -0.09375 - 2195->440; // weight: -0.09375 - 2195->452; // weight: 0.2812 - 2195->454; // weight: 0.5625 - 2248->435; // weight: -0.1250 - 2248->447; // weight: 0.3750 - 2248->451; // weight: 0.7500 - 2250->446; // weight: -0.1250 - 2250->447; // weight: 0.3750 - 2250->452; // weight: 0.7500 - 2253->434; // weight: 0.01562 - 2253->435; // weight: -0.04688 - 2253->446; // weight: -0.04688 - 2253->447; // weight: 0.1406 - 2253->449; // weight: -0.09375 - 2253->451; // weight: 0.2812 - 2253->440; // weight: -0.09375 - 2253->452; // weight: 0.2812 - 2253->454; // weight: 0.5625 - 1018->467; // weight: 1.000 - 1020->474; // weight: 1.000 - 1026->467; // weight: 0.3750 - 1026->468; // weight: -0.1250 - 1026->474; // weight: 0.7500 - 1027->1; // weight: 0.3750 - 1027->464; // weight: -0.1250 - 1027->467; // weight: 0.7500 - 1028->9; // weight: 0.3750 - 1028->466; // weight: -0.1250 - 1028->474; // weight: 0.7500 - 1041->1; // weight: 0.1406 - 1041->464; // weight: -0.04688 - 1041->3; // weight: -0.04688 - 1041->465; // weight: 0.01562 - 1041->9; // weight: 0.2812 - 1041->466; // weight: -0.09375 - 1041->467; // weight: 0.2812 - 1041->468; // weight: -0.09375 - 1041->474; // weight: 0.5625 - 1044->466; // weight: 1.000 - 1047->464; // weight: 0.3750 - 1047->465; // weight: -0.1250 - 1047->466; // weight: 0.7500 - 1048->1; // weight: -0.1250 - 1048->464; // weight: 0.3750 - 1048->467; // weight: 0.7500 - 1049->9; // weight: -0.1250 - 1049->466; // weight: 0.3750 - 1049->474; // weight: 0.7500 - 1058->1; // weight: -0.04688 - 1058->464; // weight: 0.1406 - 1058->3; // weight: 0.01562 - 1058->465; // weight: -0.04688 - 1058->9; // weight: -0.09375 - 1058->466; // weight: 0.2812 - 1058->467; // weight: 0.2812 - 1058->468; // weight: -0.09375 - 1058->474; // weight: 0.5625 - 1061->468; // weight: 1.000 - 1065->467; // weight: -0.1250 - 1065->468; // weight: 0.3750 - 1065->474; // weight: 0.7500 - 1066->3; // weight: 0.3750 - 1066->465; // weight: -0.1250 - 1066->468; // weight: 0.7500 - 1075->1; // weight: -0.04688 - 1075->464; // weight: 0.01562 - 1075->3; // weight: 0.1406 - 1075->465; // weight: -0.04688 - 1075->9; // weight: 0.2812 - 1075->466; // weight: -0.09375 - 1075->467; // weight: -0.09375 - 1075->468; // weight: 0.2812 - 1075->474; // weight: 0.5625 - 1079->464; // weight: -0.1250 - 1079->465; // weight: 0.3750 - 1079->466; // weight: 0.7500 - 1080->3; // weight: -0.1250 - 1080->465; // weight: 0.3750 - 1080->468; // weight: 0.7500 - 1086->1; // weight: 0.01562 - 1086->464; // weight: -0.04688 - 1086->3; // weight: -0.04688 - 1086->465; // weight: 0.1406 - 1086->9; // weight: -0.09375 - 1086->466; // weight: 0.2812 - 1086->467; // weight: -0.09375 - 1086->468; // weight: 0.2812 - 1086->474; // weight: 0.5625 - 27->2; // weight: 0.3750 - 27->390; // weight: -0.1250 - 27->391; // weight: 0.7500 - 28->391; // weight: 1.000 - 29->2; // weight: -0.1250 - 29->390; // weight: 0.3750 - 29->391; // weight: 0.7500 - 30->3; // weight: 0.3750 - 30->476; // weight: -0.1250 - 30->477; // weight: 0.7500 - 36->390; // weight: 0.3750 - 36->476; // weight: -0.1250 - 36->478; // weight: 0.7500 - 37->478; // weight: 1.000 - 38->390; // weight: -0.1250 - 38->476; // weight: 0.3750 - 38->478; // weight: 0.7500 - 97->2; // weight: 0.1406 - 97->3; // weight: -0.04688 - 97->390; // weight: -0.04688 - 97->476; // weight: 0.01562 - 97->391; // weight: 0.2812 - 97->477; // weight: -0.09375 - 97->11; // weight: 0.2812 - 97->478; // weight: -0.09375 - 97->482; // weight: 0.5625 - 98->11; // weight: 0.3750 - 98->478; // weight: -0.1250 - 98->482; // weight: 0.7500 - 99->2; // weight: -0.04688 - 99->3; // weight: 0.1406 - 99->390; // weight: 0.01562 - 99->476; // weight: -0.04688 - 99->391; // weight: -0.09375 - 99->477; // weight: 0.2812 - 99->11; // weight: 0.2812 - 99->478; // weight: -0.09375 - 99->482; // weight: 0.5625 - 100->391; // weight: 0.3750 - 100->477; // weight: -0.1250 - 100->482; // weight: 0.7500 - 101->391; // weight: -0.1250 - 101->477; // weight: 0.3750 - 101->482; // weight: 0.7500 - 102->2; // weight: -0.04688 - 102->3; // weight: 0.01562 - 102->390; // weight: 0.1406 - 102->476; // weight: -0.04688 - 102->391; // weight: 0.2812 - 102->477; // weight: -0.09375 - 102->11; // weight: -0.09375 - 102->478; // weight: 0.2812 - 102->482; // weight: 0.5625 - 103->11; // weight: -0.1250 - 103->478; // weight: 0.3750 - 103->482; // weight: 0.7500 - 104->2; // weight: 0.01562 - 104->3; // weight: -0.04688 - 104->390; // weight: -0.04688 - 104->476; // weight: 0.1406 - 104->391; // weight: -0.09375 - 104->477; // weight: 0.2812 - 104->11; // weight: -0.09375 - 104->478; // weight: 0.2812 - 104->482; // weight: 0.5625 - 2472->479; // weight: 1.000 - 2473->489; // weight: 1.000 - 2478->479; // weight: 0.3750 - 2478->487; // weight: -0.1250 - 2478->489; // weight: 0.7500 - 2480->435; // weight: 0.3750 - 2480->476; // weight: -0.1250 - 2480->479; // weight: 0.7500 - 2481->451; // weight: 0.3750 - 2481->486; // weight: -0.1250 - 2481->489; // weight: 0.7500 - 2486->435; // weight: 0.1406 - 2486->476; // weight: -0.04688 - 2486->447; // weight: -0.04688 - 2486->484; // weight: 0.01562 - 2486->451; // weight: 0.2812 - 2486->486; // weight: -0.09375 - 2486->479; // weight: 0.2812 - 2486->487; // weight: -0.09375 - 2486->489; // weight: 0.5625 - 1167->486; // weight: 1.000 - 1172->476; // weight: 0.3750 - 1172->484; // weight: -0.1250 - 1172->486; // weight: 0.7500 - 2527->435; // weight: -0.1250 - 2527->476; // weight: 0.3750 - 2527->479; // weight: 0.7500 - 2528->451; // weight: -0.1250 - 2528->486; // weight: 0.3750 - 2528->489; // weight: 0.7500 - 2533->435; // weight: -0.04688 - 2533->476; // weight: 0.1406 - 2533->447; // weight: 0.01562 - 2533->484; // weight: -0.04688 - 2533->451; // weight: -0.09375 - 2533->486; // weight: 0.2812 - 2533->479; // weight: 0.2812 - 2533->487; // weight: -0.09375 - 2533->489; // weight: 0.5625 - 2490->487; // weight: 1.000 - 2493->479; // weight: -0.1250 - 2493->487; // weight: 0.3750 - 2493->489; // weight: 0.7500 - 2495->447; // weight: 0.3750 - 2495->484; // weight: -0.1250 - 2495->487; // weight: 0.7500 - 2498->435; // weight: -0.04688 - 2498->476; // weight: 0.01562 - 2498->447; // weight: 0.1406 - 2498->484; // weight: -0.04688 - 2498->451; // weight: 0.2812 - 2498->486; // weight: -0.09375 - 2498->479; // weight: -0.09375 - 2498->487; // weight: 0.2812 - 2498->489; // weight: 0.5625 - 1186->476; // weight: -0.1250 - 1186->484; // weight: 0.3750 - 1186->486; // weight: 0.7500 - 2540->447; // weight: -0.1250 - 2540->484; // weight: 0.3750 - 2540->487; // weight: 0.7500 - 2543->435; // weight: 0.01562 - 2543->476; // weight: -0.04688 - 2543->447; // weight: -0.04688 - 2543->484; // weight: 0.1406 - 2543->451; // weight: -0.09375 - 2543->486; // weight: 0.2812 - 2543->479; // weight: -0.09375 - 2543->487; // weight: 0.2812 - 2543->489; // weight: 0.5625 - 1138->490; // weight: 1.000 - 1142->468; // weight: 0.3750 - 1142->486; // weight: -0.1250 - 1142->490; // weight: 0.7500 - 1143->477; // weight: 0.3750 - 1143->485; // weight: -0.1250 - 1143->490; // weight: 0.7500 - 1152->3; // weight: 0.1406 - 1152->465; // weight: -0.04688 - 1152->476; // weight: -0.04688 - 1152->484; // weight: 0.01562 - 1152->477; // weight: 0.2812 - 1152->485; // weight: -0.09375 - 1152->468; // weight: 0.2812 - 1152->486; // weight: -0.09375 - 1152->490; // weight: 0.5625 - 1155->485; // weight: 1.000 - 1157->465; // weight: 0.3750 - 1157->484; // weight: -0.1250 - 1157->485; // weight: 0.7500 - 1158->477; // weight: -0.1250 - 1158->485; // weight: 0.3750 - 1158->490; // weight: 0.7500 - 1164->3; // weight: -0.04688 - 1164->465; // weight: 0.1406 - 1164->476; // weight: 0.01562 - 1164->484; // weight: -0.04688 - 1164->477; // weight: -0.09375 - 1164->485; // weight: 0.2812 - 1164->468; // weight: 0.2812 - 1164->486; // weight: -0.09375 - 1164->490; // weight: 0.5625 - 1171->468; // weight: -0.1250 - 1171->486; // weight: 0.3750 - 1171->490; // weight: 0.7500 - 1181->3; // weight: -0.04688 - 1181->465; // weight: 0.01562 - 1181->476; // weight: 0.1406 - 1181->484; // weight: -0.04688 - 1181->477; // weight: 0.2812 - 1181->485; // weight: -0.09375 - 1181->468; // weight: -0.09375 - 1181->486; // weight: 0.2812 - 1181->490; // weight: 0.5625 - 1185->465; // weight: -0.1250 - 1185->484; // weight: 0.3750 - 1185->485; // weight: 0.7500 - 1192->3; // weight: 0.01562 - 1192->465; // weight: -0.04688 - 1192->476; // weight: -0.04688 - 1192->484; // weight: 0.1406 - 1192->477; // weight: -0.09375 - 1192->485; // weight: 0.2812 - 1192->468; // weight: -0.09375 - 1192->486; // weight: 0.2812 - 1192->490; // weight: 0.5625 - 2277->542; // weight: 1.000 - 2279->516; // weight: 1.000 - 2281->547; // weight: 1.000 - 2291->510; // weight: 0.3750 - 2291->511; // weight: -0.1250 - 2291->516; // weight: 0.7500 - 2293->542; // weight: 0.3750 - 2293->544; // weight: -0.1250 - 2293->547; // weight: 0.7500 - 2283->510; // weight: 0.3750 - 2283->540; // weight: -0.1250 - 2283->542; // weight: 0.7500 - 2287->516; // weight: 0.3750 - 2287->546; // weight: -0.1250 - 2287->547; // weight: 0.7500 - 2295->510; // weight: 0.1406 - 2295->540; // weight: -0.04688 - 2295->511; // weight: -0.04688 - 2295->541; // weight: 0.01562 - 2295->516; // weight: 0.2812 - 2295->546; // weight: -0.09375 - 2295->542; // weight: 0.2812 - 2295->544; // weight: -0.09375 - 2295->547; // weight: 0.5625 - 2318->546; // weight: 1.000 - 2326->540; // weight: 0.3750 - 2326->541; // weight: -0.1250 - 2326->546; // weight: 0.7500 - 2320->510; // weight: -0.1250 - 2320->540; // weight: 0.3750 - 2320->542; // weight: 0.7500 - 2323->516; // weight: -0.1250 - 2323->546; // weight: 0.3750 - 2323->547; // weight: 0.7500 - 2328->510; // weight: -0.04688 - 2328->540; // weight: 0.1406 - 2328->511; // weight: 0.01562 - 2328->541; // weight: -0.04688 - 2328->516; // weight: -0.09375 - 2328->546; // weight: 0.2812 - 2328->542; // weight: 0.2812 - 2328->544; // weight: -0.09375 - 2328->547; // weight: 0.5625 - 2347->544; // weight: 1.000 - 2353->510; // weight: -0.1250 - 2353->511; // weight: 0.3750 - 2353->516; // weight: 0.7500 - 2355->542; // weight: -0.1250 - 2355->544; // weight: 0.3750 - 2355->547; // weight: 0.7500 - 2349->511; // weight: 0.3750 - 2349->541; // weight: -0.1250 - 2349->544; // weight: 0.7500 - 2357->510; // weight: -0.04688 - 2357->540; // weight: 0.01562 - 2357->511; // weight: 0.1406 - 2357->541; // weight: -0.04688 - 2357->516; // weight: 0.2812 - 2357->546; // weight: -0.09375 - 2357->542; // weight: -0.09375 - 2357->544; // weight: 0.2812 - 2357->547; // weight: 0.5625 - 2377->540; // weight: -0.1250 - 2377->541; // weight: 0.3750 - 2377->546; // weight: 0.7500 - 2374->511; // weight: -0.1250 - 2374->541; // weight: 0.3750 - 2374->544; // weight: 0.7500 - 2379->510; // weight: 0.01562 - 2379->540; // weight: -0.04688 - 2379->511; // weight: -0.04688 - 2379->541; // weight: 0.1406 - 2379->516; // weight: -0.09375 - 2379->546; // weight: 0.2812 - 2379->542; // weight: -0.09375 - 2379->544; // weight: 0.2812 - 2379->547; // weight: 0.5625 - 171->390; // weight: 0.3750 - 171->558; // weight: -0.1250 - 171->559; // weight: 0.7500 - 172->559; // weight: 1.000 - 173->390; // weight: -0.1250 - 173->558; // weight: 0.3750 - 173->559; // weight: 0.7500 - 174->142; // weight: 0.3750 - 174->390; // weight: -0.1250 - 174->392; // weight: 0.7500 - 175->392; // weight: 1.000 - 176->142; // weight: -0.1250 - 176->390; // weight: 0.3750 - 176->392; // weight: 0.7500 - 177->144; // weight: 0.3750 - 177->558; // weight: -0.1250 - 177->560; // weight: 0.7500 - 235->142; // weight: 0.1406 - 235->390; // weight: -0.04688 - 235->144; // weight: -0.04688 - 235->558; // weight: 0.01562 - 235->150; // weight: 0.2812 - 235->559; // weight: -0.09375 - 235->392; // weight: 0.2812 - 235->560; // weight: -0.09375 - 235->564; // weight: 0.5625 - 236->392; // weight: 0.3750 - 236->560; // weight: -0.1250 - 236->564; // weight: 0.7500 - 237->142; // weight: -0.04688 - 237->390; // weight: 0.1406 - 237->144; // weight: 0.01562 - 237->558; // weight: -0.04688 - 237->150; // weight: -0.09375 - 237->559; // weight: 0.2812 - 237->392; // weight: 0.2812 - 237->560; // weight: -0.09375 - 237->564; // weight: 0.5625 - 238->150; // weight: 0.3750 - 238->559; // weight: -0.1250 - 238->564; // weight: 0.7500 - 239->150; // weight: -0.1250 - 239->559; // weight: 0.3750 - 239->564; // weight: 0.7500 - 240->142; // weight: -0.04688 - 240->390; // weight: 0.01562 - 240->144; // weight: 0.1406 - 240->558; // weight: -0.04688 - 240->150; // weight: 0.2812 - 240->559; // weight: -0.09375 - 240->392; // weight: -0.09375 - 240->560; // weight: 0.2812 - 240->564; // weight: 0.5625 - 241->392; // weight: -0.1250 - 241->560; // weight: 0.3750 - 241->564; // weight: 0.7500 - 242->142; // weight: 0.01562 - 242->390; // weight: -0.04688 - 242->144; // weight: -0.04688 - 242->558; // weight: 0.1406 - 242->150; // weight: -0.09375 - 242->559; // weight: 0.2812 - 242->392; // weight: -0.09375 - 242->560; // weight: 0.2812 - 242->564; // weight: 0.5625 - 1590->568; // weight: 1.000 - 1591->576; // weight: 1.000 - 1596->143; // weight: 0.3750 - 1596->566; // weight: -0.1250 - 1596->568; // weight: 0.7500 - 1597->152; // weight: 0.3750 - 1597->570; // weight: -0.1250 - 1597->576; // weight: 0.7500 - 1599->568; // weight: 0.3750 - 1599->569; // weight: -0.1250 - 1599->576; // weight: 0.7500 - 1612->143; // weight: 0.1406 - 1612->144; // weight: -0.04688 - 1612->566; // weight: -0.04688 - 1612->567; // weight: 0.01562 - 1612->568; // weight: 0.2812 - 1612->569; // weight: -0.09375 - 1612->152; // weight: 0.2812 - 1612->570; // weight: -0.09375 - 1612->576; // weight: 0.5625 - 1615->569; // weight: 1.000 - 1618->144; // weight: 0.3750 - 1618->567; // weight: -0.1250 - 1618->569; // weight: 0.7500 - 1620->568; // weight: -0.1250 - 1620->569; // weight: 0.3750 - 1620->576; // weight: 0.7500 - 1629->143; // weight: -0.04688 - 1629->144; // weight: 0.1406 - 1629->566; // weight: 0.01562 - 1629->567; // weight: -0.04688 - 1629->568; // weight: -0.09375 - 1629->569; // weight: 0.2812 - 1629->152; // weight: 0.2812 - 1629->570; // weight: -0.09375 - 1629->576; // weight: 0.5625 - 1632->570; // weight: 1.000 - 1635->143; // weight: -0.1250 - 1635->566; // weight: 0.3750 - 1635->568; // weight: 0.7500 - 1636->152; // weight: -0.1250 - 1636->570; // weight: 0.3750 - 1636->576; // weight: 0.7500 - 1637->566; // weight: 0.3750 - 1637->567; // weight: -0.1250 - 1637->570; // weight: 0.7500 - 1646->143; // weight: -0.04688 - 1646->144; // weight: 0.01562 - 1646->566; // weight: 0.1406 - 1646->567; // weight: -0.04688 - 1646->568; // weight: 0.2812 - 1646->569; // weight: -0.09375 - 1646->152; // weight: -0.09375 - 1646->570; // weight: 0.2812 - 1646->576; // weight: 0.5625 - 1650->144; // weight: -0.1250 - 1650->567; // weight: 0.3750 - 1650->569; // weight: 0.7500 - 1651->566; // weight: -0.1250 - 1651->567; // weight: 0.3750 - 1651->570; // weight: 0.7500 - 1657->143; // weight: 0.01562 - 1657->144; // weight: -0.04688 - 1657->566; // weight: -0.04688 - 1657->567; // weight: 0.1406 - 1657->568; // weight: -0.09375 - 1657->569; // weight: 0.2812 - 1657->152; // weight: -0.09375 - 1657->570; // weight: 0.2812 - 1657->576; // weight: 0.5625 - 2566->561; // weight: 1.000 - 2568->582; // weight: 1.000 - 2574->511; // weight: 0.3750 - 2574->558; // weight: -0.1250 - 2574->561; // weight: 0.7500 - 2576->544; // weight: 0.3750 - 2576->579; // weight: -0.1250 - 2576->582; // weight: 0.7500 - 2570->561; // weight: 0.3750 - 2570->581; // weight: -0.1250 - 2570->582; // weight: 0.7500 - 2578->511; // weight: 0.1406 - 2578->541; // weight: -0.04688 - 2578->558; // weight: -0.04688 - 2578->578; // weight: 0.01562 - 2578->561; // weight: 0.2812 - 2578->581; // weight: -0.09375 - 2578->544; // weight: 0.2812 - 2578->579; // weight: -0.09375 - 2578->582; // weight: 0.5625 - 2594->581; // weight: 1.000 - 2599->541; // weight: 0.3750 - 2599->578; // weight: -0.1250 - 2599->581; // weight: 0.7500 - 2596->561; // weight: -0.1250 - 2596->581; // weight: 0.3750 - 2596->582; // weight: 0.7500 - 2601->511; // weight: -0.04688 - 2601->541; // weight: 0.1406 - 2601->558; // weight: 0.01562 - 2601->578; // weight: -0.04688 - 2601->561; // weight: -0.09375 - 2601->581; // weight: 0.2812 - 2601->544; // weight: 0.2812 - 2601->579; // weight: -0.09375 - 2601->582; // weight: 0.5625 - 1726->579; // weight: 1.000 - 2619->511; // weight: -0.1250 - 2619->558; // weight: 0.3750 - 2619->561; // weight: 0.7500 - 2621->544; // weight: -0.1250 - 2621->579; // weight: 0.3750 - 2621->582; // weight: 0.7500 - 1729->558; // weight: 0.3750 - 1729->578; // weight: -0.1250 - 1729->579; // weight: 0.7500 - 2623->511; // weight: -0.04688 - 2623->541; // weight: 0.01562 - 2623->558; // weight: 0.1406 - 2623->578; // weight: -0.04688 - 2623->561; // weight: 0.2812 - 2623->581; // weight: -0.09375 - 2623->544; // weight: -0.09375 - 2623->579; // weight: 0.2812 - 2623->582; // weight: 0.5625 - 2642->541; // weight: -0.1250 - 2642->578; // weight: 0.3750 - 2642->581; // weight: 0.7500 - 1756->558; // weight: -0.1250 - 1756->578; // weight: 0.3750 - 1756->579; // weight: 0.7500 - 2644->511; // weight: 0.01562 - 2644->541; // weight: -0.04688 - 2644->558; // weight: -0.04688 - 2644->578; // weight: 0.1406 - 2644->561; // weight: -0.09375 - 2644->581; // weight: 0.2812 - 2644->544; // weight: -0.09375 - 2644->579; // weight: 0.2812 - 2644->582; // weight: 0.5625 - 1709->584; // weight: 1.000 - 1712->560; // weight: 0.3750 - 1712->580; // weight: -0.1250 - 1712->584; // weight: 0.7500 - 1714->569; // weight: 0.3750 - 1714->579; // weight: -0.1250 - 1714->584; // weight: 0.7500 - 1723->144; // weight: 0.1406 - 1723->558; // weight: -0.04688 - 1723->567; // weight: -0.04688 - 1723->578; // weight: 0.01562 - 1723->569; // weight: 0.2812 - 1723->579; // weight: -0.09375 - 1723->560; // weight: 0.2812 - 1723->580; // weight: -0.09375 - 1723->584; // weight: 0.5625 - 1731->569; // weight: -0.1250 - 1731->579; // weight: 0.3750 - 1731->584; // weight: 0.7500 - 1740->144; // weight: -0.04688 - 1740->558; // weight: 0.1406 - 1740->567; // weight: 0.01562 - 1740->578; // weight: -0.04688 - 1740->569; // weight: -0.09375 - 1740->579; // weight: 0.2812 - 1740->560; // weight: 0.2812 - 1740->580; // weight: -0.09375 - 1740->584; // weight: 0.5625 - 1743->580; // weight: 1.000 - 1745->560; // weight: -0.1250 - 1745->580; // weight: 0.3750 - 1745->584; // weight: 0.7500 - 1746->567; // weight: 0.3750 - 1746->578; // weight: -0.1250 - 1746->580; // weight: 0.7500 - 1752->144; // weight: -0.04688 - 1752->558; // weight: 0.01562 - 1752->567; // weight: 0.1406 - 1752->578; // weight: -0.04688 - 1752->569; // weight: 0.2812 - 1752->579; // weight: -0.09375 - 1752->560; // weight: -0.09375 - 1752->580; // weight: 0.2812 - 1752->584; // weight: 0.5625 - 1757->567; // weight: -0.1250 - 1757->578; // weight: 0.3750 - 1757->580; // weight: 0.7500 - 1763->144; // weight: 0.01562 - 1763->558; // weight: -0.04688 - 1763->567; // weight: -0.04688 - 1763->578; // weight: 0.1406 - 1763->569; // weight: -0.09375 - 1763->579; // weight: 0.2812 - 1763->560; // weight: -0.09375 - 1763->580; // weight: 0.2812 - 1763->584; // weight: 0.5625 - 2158->588; // weight: 1.000 - 2162->593; // weight: 1.000 - 2174->588; // weight: 0.3750 - 2174->590; // weight: -0.1250 - 2174->593; // weight: 0.7500 - 2164->434; // weight: 0.3750 - 2164->586; // weight: -0.1250 - 2164->588; // weight: 0.7500 - 2168->440; // weight: 0.3750 - 2168->592; // weight: -0.1250 - 2168->593; // weight: 0.7500 - 2176->434; // weight: 0.1406 - 2176->586; // weight: -0.04688 - 2176->435; // weight: -0.04688 - 2176->587; // weight: 0.01562 - 2176->440; // weight: 0.2812 - 2176->592; // weight: -0.09375 - 2176->588; // weight: 0.2812 - 2176->590; // weight: -0.09375 - 2176->593; // weight: 0.5625 - 2201->592; // weight: 1.000 - 2209->586; // weight: 0.3750 - 2209->587; // weight: -0.1250 - 2209->592; // weight: 0.7500 - 2203->434; // weight: -0.1250 - 2203->586; // weight: 0.3750 - 2203->588; // weight: 0.7500 - 2206->440; // weight: -0.1250 - 2206->592; // weight: 0.3750 - 2206->593; // weight: 0.7500 - 2211->434; // weight: -0.04688 - 2211->586; // weight: 0.1406 - 2211->435; // weight: 0.01562 - 2211->587; // weight: -0.04688 - 2211->440; // weight: -0.09375 - 2211->592; // weight: 0.2812 - 2211->588; // weight: 0.2812 - 2211->590; // weight: -0.09375 - 2211->593; // weight: 0.5625 - 2230->590; // weight: 1.000 - 2238->588; // weight: -0.1250 - 2238->590; // weight: 0.3750 - 2238->593; // weight: 0.7500 - 2232->435; // weight: 0.3750 - 2232->587; // weight: -0.1250 - 2232->590; // weight: 0.7500 - 2240->434; // weight: -0.04688 - 2240->586; // weight: 0.01562 - 2240->435; // weight: 0.1406 - 2240->587; // weight: -0.04688 - 2240->440; // weight: 0.2812 - 2240->592; // weight: -0.09375 - 2240->588; // weight: -0.09375 - 2240->590; // weight: 0.2812 - 2240->593; // weight: 0.5625 - 2261->586; // weight: -0.1250 - 2261->587; // weight: 0.3750 - 2261->592; // weight: 0.7500 - 2258->435; // weight: -0.1250 - 2258->587; // weight: 0.3750 - 2258->590; // weight: 0.7500 - 2263->434; // weight: 0.01562 - 2263->586; // weight: -0.04688 - 2263->435; // weight: -0.04688 - 2263->587; // weight: 0.1406 - 2263->440; // weight: -0.09375 - 2263->592; // weight: 0.2812 - 2263->588; // weight: -0.09375 - 2263->590; // weight: 0.2812 - 2263->593; // weight: 0.5625 - 2276->589; // weight: 1.000 - 2280->594; // weight: 1.000 - 2285->510; // weight: 0.3750 - 2285->586; // weight: -0.1250 - 2285->589; // weight: 0.7500 - 2289->516; // weight: 0.3750 - 2289->592; // weight: -0.1250 - 2289->594; // weight: 0.7500 - 2292->589; // weight: 0.3750 - 2292->591; // weight: -0.1250 - 2292->594; // weight: 0.7500 - 2297->510; // weight: 0.1406 - 2297->511; // weight: -0.04688 - 2297->586; // weight: -0.04688 - 2297->587; // weight: 0.01562 - 2297->589; // weight: 0.2812 - 2297->591; // weight: -0.09375 - 2297->516; // weight: 0.2812 - 2297->592; // weight: -0.09375 - 2297->594; // weight: 0.5625 - 2346->591; // weight: 1.000 - 2351->511; // weight: 0.3750 - 2351->587; // weight: -0.1250 - 2351->591; // weight: 0.7500 - 2354->589; // weight: -0.1250 - 2354->591; // weight: 0.3750 - 2354->594; // weight: 0.7500 - 2359->510; // weight: -0.04688 - 2359->511; // weight: 0.1406 - 2359->586; // weight: 0.01562 - 2359->587; // weight: -0.04688 - 2359->589; // weight: -0.09375 - 2359->591; // weight: 0.2812 - 2359->516; // weight: 0.2812 - 2359->592; // weight: -0.09375 - 2359->594; // weight: 0.5625 - 2305->510; // weight: -0.1250 - 2305->586; // weight: 0.3750 - 2305->589; // weight: 0.7500 - 2308->516; // weight: -0.1250 - 2308->592; // weight: 0.3750 - 2308->594; // weight: 0.7500 - 2312->510; // weight: -0.04688 - 2312->511; // weight: 0.01562 - 2312->586; // weight: 0.1406 - 2312->587; // weight: -0.04688 - 2312->589; // weight: 0.2812 - 2312->591; // weight: -0.09375 - 2312->516; // weight: -0.09375 - 2312->592; // weight: 0.2812 - 2312->594; // weight: 0.5625 - 2365->511; // weight: -0.1250 - 2365->587; // weight: 0.3750 - 2365->591; // weight: 0.7500 - 2369->510; // weight: 0.01562 - 2369->511; // weight: -0.04688 - 2369->586; // weight: -0.04688 - 2369->587; // weight: 0.1406 - 2369->589; // weight: -0.09375 - 2369->591; // weight: 0.2812 - 2369->516; // weight: -0.09375 - 2369->592; // weight: 0.2812 - 2369->594; // weight: 0.5625 - 2474->602; // weight: 1.000 - 2482->590; // weight: 0.3750 - 2482->599; // weight: -0.1250 - 2482->602; // weight: 0.7500 - 2476->479; // weight: 0.3750 - 2476->601; // weight: -0.1250 - 2476->602; // weight: 0.7500 - 2484->435; // weight: 0.1406 - 2484->587; // weight: -0.04688 - 2484->476; // weight: -0.04688 - 2484->598; // weight: 0.01562 - 2484->479; // weight: 0.2812 - 2484->601; // weight: -0.09375 - 2484->590; // weight: 0.2812 - 2484->599; // weight: -0.09375 - 2484->602; // weight: 0.5625 - 2502->601; // weight: 1.000 - 2507->587; // weight: 0.3750 - 2507->598; // weight: -0.1250 - 2507->601; // weight: 0.7500 - 2504->479; // weight: -0.1250 - 2504->601; // weight: 0.3750 - 2504->602; // weight: 0.7500 - 2509->435; // weight: -0.04688 - 2509->587; // weight: 0.1406 - 2509->476; // weight: 0.01562 - 2509->598; // weight: -0.04688 - 2509->479; // weight: -0.09375 - 2509->601; // weight: 0.2812 - 2509->590; // weight: 0.2812 - 2509->599; // weight: -0.09375 - 2509->602; // weight: 0.5625 - 2522->599; // weight: 1.000 - 2529->590; // weight: -0.1250 - 2529->599; // weight: 0.3750 - 2529->602; // weight: 0.7500 - 2524->476; // weight: 0.3750 - 2524->598; // weight: -0.1250 - 2524->599; // weight: 0.7500 - 2531->435; // weight: -0.04688 - 2531->587; // weight: 0.01562 - 2531->476; // weight: 0.1406 - 2531->598; // weight: -0.04688 - 2531->479; // weight: 0.2812 - 2531->601; // weight: -0.09375 - 2531->590; // weight: -0.09375 - 2531->599; // weight: 0.2812 - 2531->602; // weight: 0.5625 - 2551->587; // weight: -0.1250 - 2551->598; // weight: 0.3750 - 2551->601; // weight: 0.7500 - 2548->476; // weight: -0.1250 - 2548->598; // weight: 0.3750 - 2548->599; // weight: 0.7500 - 2553->435; // weight: 0.01562 - 2553->587; // weight: -0.04688 - 2553->476; // weight: -0.04688 - 2553->598; // weight: 0.1406 - 2553->479; // weight: -0.09375 - 2553->601; // weight: 0.2812 - 2553->590; // weight: -0.09375 - 2553->599; // weight: 0.2812 - 2553->602; // weight: 0.5625 - 2567->603; // weight: 1.000 - 2572->561; // weight: 0.3750 - 2572->601; // weight: -0.1250 - 2572->603; // weight: 0.7500 - 2575->591; // weight: 0.3750 - 2575->600; // weight: -0.1250 - 2575->603; // weight: 0.7500 - 2580->511; // weight: 0.1406 - 2580->558; // weight: -0.04688 - 2580->587; // weight: -0.04688 - 2580->598; // weight: 0.01562 - 2580->591; // weight: 0.2812 - 2580->600; // weight: -0.09375 - 2580->561; // weight: 0.2812 - 2580->601; // weight: -0.09375 - 2580->603; // weight: 0.5625 - 2614->600; // weight: 1.000 - 2617->558; // weight: 0.3750 - 2617->598; // weight: -0.1250 - 2617->600; // weight: 0.7500 - 2620->591; // weight: -0.1250 - 2620->600; // weight: 0.3750 - 2620->603; // weight: 0.7500 - 2625->511; // weight: -0.04688 - 2625->558; // weight: 0.1406 - 2625->587; // weight: 0.01562 - 2625->598; // weight: -0.04688 - 2625->591; // weight: -0.09375 - 2625->600; // weight: 0.2812 - 2625->561; // weight: 0.2812 - 2625->601; // weight: -0.09375 - 2625->603; // weight: 0.5625 - 2586->561; // weight: -0.1250 - 2586->601; // weight: 0.3750 - 2586->603; // weight: 0.7500 - 2590->511; // weight: -0.04688 - 2590->558; // weight: 0.01562 - 2590->587; // weight: 0.1406 - 2590->598; // weight: -0.04688 - 2590->591; // weight: 0.2812 - 2590->600; // weight: -0.09375 - 2590->561; // weight: -0.09375 - 2590->601; // weight: 0.2812 - 2590->603; // weight: 0.5625 - 2631->558; // weight: -0.1250 - 2631->598; // weight: 0.3750 - 2631->600; // weight: 0.7500 - 2635->511; // weight: 0.01562 - 2635->558; // weight: -0.04688 - 2635->587; // weight: -0.04688 - 2635->598; // weight: 0.1406 - 2635->591; // weight: -0.09375 - 2635->600; // weight: 0.2812 - 2635->561; // weight: -0.09375 - 2635->601; // weight: 0.2812 - 2635->603; // weight: 0.5625 - 695->390; // weight: 0.2222 - 695->558; // weight: -0.1111 - 695->559; // weight: 0.8889 - 696->390; // weight: -0.1111 - 696->558; // weight: 0.2222 - 696->559; // weight: 0.8889 - 697->476; // weight: 0.2222 - 697->598; // weight: -0.1111 - 697->599; // weight: 0.8889 - 698->476; // weight: -0.1111 - 698->598; // weight: 0.2222 - 698->599; // weight: 0.8889 - 699->390; // weight: 0.2222 - 699->476; // weight: -0.1111 - 699->478; // weight: 0.8889 - 700->390; // weight: -0.1111 - 700->476; // weight: 0.2222 - 700->478; // weight: 0.8889 - 701->558; // weight: 0.2222 - 701->598; // weight: -0.1111 - 701->600; // weight: 0.8889 - 702->558; // weight: -0.1111 - 702->598; // weight: 0.2222 - 702->600; // weight: 0.8889 - 735->390; // weight: 0.04938 - 735->476; // weight: -0.02469 - 735->558; // weight: -0.02469 - 735->598; // weight: 0.01235 - 735->559; // weight: 0.1975 - 735->599; // weight: -0.09877 - 735->478; // weight: 0.1975 - 735->600; // weight: -0.09877 - 735->604; // weight: 0.7901 - 736->390; // weight: -0.02469 - 736->476; // weight: 0.04938 - 736->558; // weight: 0.01235 - 736->598; // weight: -0.02469 - 736->559; // weight: -0.09877 - 736->599; // weight: 0.1975 - 736->478; // weight: 0.1975 - 736->600; // weight: -0.09877 - 736->604; // weight: 0.7901 - 737->390; // weight: -0.02469 - 737->476; // weight: 0.01235 - 737->558; // weight: 0.04938 - 737->598; // weight: -0.02469 - 737->559; // weight: 0.1975 - 737->599; // weight: -0.09877 - 737->478; // weight: -0.09877 - 737->600; // weight: 0.1975 - 737->604; // weight: 0.7901 - 738->390; // weight: 0.01235 - 738->476; // weight: -0.02469 - 738->558; // weight: -0.02469 - 738->598; // weight: 0.04938 - 738->559; // weight: -0.09877 - 738->599; // weight: 0.1975 - 738->478; // weight: -0.09877 - 738->600; // weight: 0.1975 - 738->604; // weight: 0.7901 - 57->390; // weight: 0.3750 - 57->636; // weight: -0.1250 - 57->639; // weight: 0.7500 - 58->639; // weight: 1.000 - 59->390; // weight: -0.1250 - 59->636; // weight: 0.3750 - 59->639; // weight: 0.7500 - 39->6; // weight: 0.3750 - 39->636; // weight: -0.1250 - 39->637; // weight: 0.7500 - 63->2; // weight: 0.1406 - 63->390; // weight: -0.04688 - 63->6; // weight: -0.04688 - 63->636; // weight: 0.01562 - 63->18; // weight: 0.2812 - 63->639; // weight: -0.09375 - 63->391; // weight: 0.2812 - 63->637; // weight: -0.09375 - 63->640; // weight: 0.5625 - 64->391; // weight: 0.3750 - 64->637; // weight: -0.1250 - 64->640; // weight: 0.7500 - 65->2; // weight: -0.04688 - 65->390; // weight: 0.1406 - 65->6; // weight: 0.01562 - 65->636; // weight: -0.04688 - 65->18; // weight: -0.09375 - 65->639; // weight: 0.2812 - 65->391; // weight: 0.2812 - 65->637; // weight: -0.09375 - 65->640; // weight: 0.5625 - 66->18; // weight: 0.3750 - 66->639; // weight: -0.1250 - 66->640; // weight: 0.7500 - 67->18; // weight: -0.1250 - 67->639; // weight: 0.3750 - 67->640; // weight: 0.7500 - 68->2; // weight: -0.04688 - 68->390; // weight: 0.01562 - 68->6; // weight: 0.1406 - 68->636; // weight: -0.04688 - 68->18; // weight: 0.2812 - 68->639; // weight: -0.09375 - 68->391; // weight: -0.09375 - 68->637; // weight: 0.2812 - 68->640; // weight: 0.5625 - 69->391; // weight: -0.1250 - 69->637; // weight: 0.3750 - 69->640; // weight: 0.7500 - 70->2; // weight: 0.01562 - 70->390; // weight: -0.04688 - 70->6; // weight: -0.04688 - 70->636; // weight: 0.1406 - 70->18; // weight: -0.09375 - 70->639; // weight: 0.2812 - 70->391; // weight: -0.09375 - 70->637; // weight: 0.2812 - 70->640; // weight: 0.5625 - 186->146; // weight: 0.3750 - 186->636; // weight: -0.1250 - 186->638; // weight: 0.7500 - 218->142; // weight: 0.1406 - 218->146; // weight: -0.04688 - 218->390; // weight: -0.04688 - 218->636; // weight: 0.01562 - 218->392; // weight: 0.2812 - 218->638; // weight: -0.09375 - 218->158; // weight: 0.2812 - 218->639; // weight: -0.09375 - 218->641; // weight: 0.5625 - 219->158; // weight: 0.3750 - 219->639; // weight: -0.1250 - 219->641; // weight: 0.7500 - 220->142; // weight: -0.04688 - 220->146; // weight: 0.1406 - 220->390; // weight: 0.01562 - 220->636; // weight: -0.04688 - 220->392; // weight: -0.09375 - 220->638; // weight: 0.2812 - 220->158; // weight: 0.2812 - 220->639; // weight: -0.09375 - 220->641; // weight: 0.5625 - 221->392; // weight: 0.3750 - 221->638; // weight: -0.1250 - 221->641; // weight: 0.7500 - 222->392; // weight: -0.1250 - 222->638; // weight: 0.3750 - 222->641; // weight: 0.7500 - 223->142; // weight: -0.04688 - 223->146; // weight: 0.01562 - 223->390; // weight: 0.1406 - 223->636; // weight: -0.04688 - 223->392; // weight: 0.2812 - 223->638; // weight: -0.09375 - 223->158; // weight: -0.09375 - 223->639; // weight: 0.2812 - 223->641; // weight: 0.5625 - 224->158; // weight: -0.1250 - 224->639; // weight: 0.3750 - 224->641; // weight: 0.7500 - 225->142; // weight: 0.01562 - 225->146; // weight: -0.04688 - 225->390; // weight: -0.04688 - 225->636; // weight: 0.1406 - 225->392; // weight: -0.09375 - 225->638; // weight: 0.2812 - 225->158; // weight: -0.09375 - 225->639; // weight: 0.2812 - 225->641; // weight: 0.5625 - 1238->667; // weight: 1.000 - 1240->669; // weight: 1.000 - 1250->4; // weight: 0.3750 - 1250->662; // weight: -0.1250 - 1250->667; // weight: 0.7500 - 1252->12; // weight: 0.3750 - 1252->664; // weight: -0.1250 - 1252->669; // weight: 0.7500 - 1246->667; // weight: 0.3750 - 1246->668; // weight: -0.1250 - 1246->669; // weight: 0.7500 - 1254->4; // weight: 0.1406 - 1254->6; // weight: -0.04688 - 1254->662; // weight: -0.04688 - 1254->663; // weight: 0.01562 - 1254->667; // weight: 0.2812 - 1254->668; // weight: -0.09375 - 1254->12; // weight: 0.2812 - 1254->664; // weight: -0.09375 - 1254->669; // weight: 0.5625 - 1277->668; // weight: 1.000 - 1285->6; // weight: 0.3750 - 1285->663; // weight: -0.1250 - 1285->668; // weight: 0.7500 - 1282->667; // weight: -0.1250 - 1282->668; // weight: 0.3750 - 1282->669; // weight: 0.7500 - 1287->4; // weight: -0.04688 - 1287->6; // weight: 0.1406 - 1287->662; // weight: 0.01562 - 1287->663; // weight: -0.04688 - 1287->667; // weight: -0.09375 - 1287->668; // weight: 0.2812 - 1287->12; // weight: 0.2812 - 1287->664; // weight: -0.09375 - 1287->669; // weight: 0.5625 - 1304->664; // weight: 1.000 - 1310->4; // weight: -0.1250 - 1310->662; // weight: 0.3750 - 1310->667; // weight: 0.7500 - 1312->12; // weight: -0.1250 - 1312->664; // weight: 0.3750 - 1312->669; // weight: 0.7500 - 1306->662; // weight: 0.3750 - 1306->663; // weight: -0.1250 - 1306->664; // weight: 0.7500 - 1314->4; // weight: -0.04688 - 1314->6; // weight: 0.01562 - 1314->662; // weight: 0.1406 - 1314->663; // weight: -0.04688 - 1314->667; // weight: 0.2812 - 1314->668; // weight: -0.09375 - 1314->12; // weight: -0.09375 - 1314->664; // weight: 0.2812 - 1314->669; // weight: 0.5625 - 1336->6; // weight: -0.1250 - 1336->663; // weight: 0.3750 - 1336->668; // weight: 0.7500 - 1333->662; // weight: -0.1250 - 1333->663; // weight: 0.3750 - 1333->664; // weight: 0.7500 - 1338->4; // weight: 0.01562 - 1338->6; // weight: -0.04688 - 1338->662; // weight: -0.04688 - 1338->663; // weight: 0.1406 - 1338->667; // weight: -0.09375 - 1338->668; // weight: 0.2812 - 1338->12; // weight: -0.09375 - 1338->664; // weight: 0.2812 - 1338->669; // weight: 0.5625 - 1809->679; // weight: 1.000 - 1810->683; // weight: 1.000 - 1819->679; // weight: 0.3750 - 1819->680; // weight: -0.1250 - 1819->683; // weight: 0.7500 - 1821->145; // weight: 0.3750 - 1821->674; // weight: -0.1250 - 1821->679; // weight: 0.7500 - 1822->155; // weight: 0.3750 - 1822->678; // weight: -0.1250 - 1822->683; // weight: 0.7500 - 1827->145; // weight: 0.1406 - 1827->674; // weight: -0.04688 - 1827->146; // weight: -0.04688 - 1827->675; // weight: 0.01562 - 1827->155; // weight: 0.2812 - 1827->678; // weight: -0.09375 - 1827->679; // weight: 0.2812 - 1827->680; // weight: -0.09375 - 1827->683; // weight: 0.5625 - 1874->678; // weight: 1.000 - 1879->674; // weight: 0.3750 - 1879->675; // weight: -0.1250 - 1879->678; // weight: 0.7500 - 1881->145; // weight: -0.1250 - 1881->674; // weight: 0.3750 - 1881->679; // weight: 0.7500 - 1882->155; // weight: -0.1250 - 1882->678; // weight: 0.3750 - 1882->683; // weight: 0.7500 - 1887->145; // weight: -0.04688 - 1887->674; // weight: 0.1406 - 1887->146; // weight: 0.01562 - 1887->675; // weight: -0.04688 - 1887->155; // weight: -0.09375 - 1887->678; // weight: 0.2812 - 1887->679; // weight: 0.2812 - 1887->680; // weight: -0.09375 - 1887->683; // weight: 0.5625 - 1833->680; // weight: 1.000 - 1839->679; // weight: -0.1250 - 1839->680; // weight: 0.3750 - 1839->683; // weight: 0.7500 - 1841->146; // weight: 0.3750 - 1841->675; // weight: -0.1250 - 1841->680; // weight: 0.7500 - 1844->145; // weight: -0.04688 - 1844->674; // weight: 0.01562 - 1844->146; // weight: 0.1406 - 1844->675; // weight: -0.04688 - 1844->155; // weight: 0.2812 - 1844->678; // weight: -0.09375 - 1844->679; // weight: -0.09375 - 1844->680; // weight: 0.2812 - 1844->683; // weight: 0.5625 - 1893->674; // weight: -0.1250 - 1893->675; // weight: 0.3750 - 1893->678; // weight: 0.7500 - 1895->146; // weight: -0.1250 - 1895->675; // weight: 0.3750 - 1895->680; // weight: 0.7500 - 1898->145; // weight: 0.01562 - 1898->674; // weight: -0.04688 - 1898->146; // weight: -0.04688 - 1898->675; // weight: 0.1406 - 1898->155; // weight: -0.09375 - 1898->678; // weight: 0.2812 - 1898->679; // weight: -0.09375 - 1898->680; // weight: 0.2812 - 1898->683; // weight: 0.5625 - 1433->690; // weight: 1.000 - 1441->637; // weight: 0.3750 - 1441->687; // weight: -0.1250 - 1441->690; // weight: 0.7500 - 1438->668; // weight: 0.3750 - 1438->689; // weight: -0.1250 - 1438->690; // weight: 0.7500 - 1443->6; // weight: 0.1406 - 1443->636; // weight: -0.04688 - 1443->663; // weight: -0.04688 - 1443->686; // weight: 0.01562 - 1443->668; // weight: 0.2812 - 1443->689; // weight: -0.09375 - 1443->637; // weight: 0.2812 - 1443->687; // weight: -0.09375 - 1443->690; // weight: 0.5625 - 1460->689; // weight: 1.000 - 1468->636; // weight: 0.3750 - 1468->686; // weight: -0.1250 - 1468->689; // weight: 0.7500 - 1465->668; // weight: -0.1250 - 1465->689; // weight: 0.3750 - 1465->690; // weight: 0.7500 - 1470->6; // weight: -0.04688 - 1470->636; // weight: 0.1406 - 1470->663; // weight: 0.01562 - 1470->686; // weight: -0.04688 - 1470->668; // weight: -0.09375 - 1470->689; // weight: 0.2812 - 1470->637; // weight: 0.2812 - 1470->687; // weight: -0.09375 - 1470->690; // weight: 0.5625 - 1486->687; // weight: 1.000 - 1491->637; // weight: -0.1250 - 1491->687; // weight: 0.3750 - 1491->690; // weight: 0.7500 - 1488->663; // weight: 0.3750 - 1488->686; // weight: -0.1250 - 1488->687; // weight: 0.7500 - 1493->6; // weight: -0.04688 - 1493->636; // weight: 0.01562 - 1493->663; // weight: 0.1406 - 1493->686; // weight: -0.04688 - 1493->668; // weight: 0.2812 - 1493->689; // weight: -0.09375 - 1493->637; // weight: -0.09375 - 1493->687; // weight: 0.2812 - 1493->690; // weight: 0.5625 - 1510->636; // weight: -0.1250 - 1510->686; // weight: 0.3750 - 1510->689; // weight: 0.7500 - 1507->663; // weight: -0.1250 - 1507->686; // weight: 0.3750 - 1507->687; // weight: 0.7500 - 1512->6; // weight: 0.01562 - 1512->636; // weight: -0.04688 - 1512->663; // weight: -0.04688 - 1512->686; // weight: 0.1406 - 1512->668; // weight: -0.09375 - 1512->689; // weight: 0.2812 - 1512->637; // weight: -0.09375 - 1512->687; // weight: 0.2812 - 1512->690; // weight: 0.5625 - 1924->691; // weight: 1.000 - 1930->680; // weight: 0.3750 - 1930->689; // weight: -0.1250 - 1930->691; // weight: 0.7500 - 1932->638; // weight: 0.3750 - 1932->688; // weight: -0.1250 - 1932->691; // weight: 0.7500 - 1935->146; // weight: 0.1406 - 1935->675; // weight: -0.04688 - 1935->636; // weight: -0.04688 - 1935->686; // weight: 0.01562 - 1935->638; // weight: 0.2812 - 1935->688; // weight: -0.09375 - 1935->680; // weight: 0.2812 - 1935->689; // weight: -0.09375 - 1935->691; // weight: 0.5625 - 1975->688; // weight: 1.000 - 1978->675; // weight: 0.3750 - 1978->686; // weight: -0.1250 - 1978->688; // weight: 0.7500 - 1980->638; // weight: -0.1250 - 1980->688; // weight: 0.3750 - 1980->691; // weight: 0.7500 - 1983->146; // weight: -0.04688 - 1983->675; // weight: 0.1406 - 1983->636; // weight: 0.01562 - 1983->686; // weight: -0.04688 - 1983->638; // weight: -0.09375 - 1983->688; // weight: 0.2812 - 1983->680; // weight: 0.2812 - 1983->689; // weight: -0.09375 - 1983->691; // weight: 0.5625 - 1946->680; // weight: -0.1250 - 1946->689; // weight: 0.3750 - 1946->691; // weight: 0.7500 - 1950->146; // weight: -0.04688 - 1950->675; // weight: 0.01562 - 1950->636; // weight: 0.1406 - 1950->686; // weight: -0.04688 - 1950->638; // weight: 0.2812 - 1950->688; // weight: -0.09375 - 1950->680; // weight: -0.09375 - 1950->689; // weight: 0.2812 - 1950->691; // weight: 0.5625 - 1989->675; // weight: -0.1250 - 1989->686; // weight: 0.3750 - 1989->688; // weight: 0.7500 - 1993->146; // weight: 0.01562 - 1993->675; // weight: -0.04688 - 1993->636; // weight: -0.04688 - 1993->686; // weight: 0.1406 - 1993->638; // weight: -0.09375 - 1993->688; // weight: 0.2812 - 1993->680; // weight: -0.09375 - 1993->689; // weight: 0.2812 - 1993->691; // weight: 0.5625 - 198->558; // weight: 0.1172 - 198->1778; // weight: 0.03906 - 198->715; // weight: 1.055 - 198->716; // weight: -0.2109 - 183->636; // weight: 0.1172 - 183->1778; // weight: 0.03906 - 183->703; // weight: 1.055 - 183->704; // weight: -0.2109 - 209->390; // weight: 0.01373 - 209->558; // weight: 0.004578 - 209->636; // weight: 0.004578 - 209->1778; // weight: 0.001526 - 209->711; // weight: 0.1236 - 209->712; // weight: -0.02472 - 209->715; // weight: 0.04120 - 209->716; // weight: -0.008240 - 209->695; // weight: 0.1236 - 209->696; // weight: -0.02472 - 209->703; // weight: 0.04120 - 209->704; // weight: -0.008240 - 209->719; // weight: 1.112 - 209->720; // weight: -0.2225 - 209->721; // weight: -0.2225 - 209->722; // weight: 0.04449 - 210->390; // weight: -0.007324 - 210->558; // weight: -0.007324 - 210->636; // weight: -0.002441 - 210->1778; // weight: -0.002441 - 210->711; // weight: -0.06592 - 210->712; // weight: 0.01318 - 210->715; // weight: -0.06592 - 210->716; // weight: 0.01318 - 210->695; // weight: 0.06592 - 210->696; // weight: 0.06592 - 210->703; // weight: 0.02197 - 210->704; // weight: 0.02197 - 210->719; // weight: 0.5933 - 210->720; // weight: 0.5933 - 210->721; // weight: -0.1187 - 210->722; // weight: -0.1187 - 211->390; // weight: 0.004578 - 211->558; // weight: 0.01373 - 211->636; // weight: 0.001526 - 211->1778; // weight: 0.004578 - 211->711; // weight: 0.04120 - 211->712; // weight: -0.008240 - 211->715; // weight: 0.1236 - 211->716; // weight: -0.02472 - 211->695; // weight: -0.02472 - 211->696; // weight: 0.1236 - 211->703; // weight: -0.008240 - 211->704; // weight: 0.04120 - 211->719; // weight: -0.2225 - 211->720; // weight: 1.112 - 211->721; // weight: 0.04449 - 211->722; // weight: -0.2225 - 212->390; // weight: -0.007324 - 212->558; // weight: -0.002441 - 212->636; // weight: -0.007324 - 212->1778; // weight: -0.002441 - 212->711; // weight: 0.06592 - 212->712; // weight: 0.06592 - 212->715; // weight: 0.02197 - 212->716; // weight: 0.02197 - 212->695; // weight: -0.06592 - 212->696; // weight: 0.01318 - 212->703; // weight: -0.06592 - 212->704; // weight: 0.01318 - 212->719; // weight: 0.5933 - 212->720; // weight: -0.1187 - 212->721; // weight: 0.5933 - 212->722; // weight: -0.1187 - 213->390; // weight: 0.003906 - 213->558; // weight: 0.003906 - 213->636; // weight: 0.003906 - 213->1778; // weight: 0.003906 - 213->711; // weight: -0.03516 - 213->712; // weight: -0.03516 - 213->715; // weight: -0.03516 - 213->716; // weight: -0.03516 - 213->695; // weight: -0.03516 - 213->696; // weight: -0.03516 - 213->703; // weight: -0.03516 - 213->704; // weight: -0.03516 - 213->719; // weight: 0.3164 - 213->720; // weight: 0.3164 - 213->721; // weight: 0.3164 - 213->722; // weight: 0.3164 - 214->390; // weight: -0.002441 - 214->558; // weight: -0.007324 - 214->636; // weight: -0.002441 - 214->1778; // weight: -0.007324 - 214->711; // weight: 0.02197 - 214->712; // weight: 0.02197 - 214->715; // weight: 0.06592 - 214->716; // weight: 0.06592 - 214->695; // weight: 0.01318 - 214->696; // weight: -0.06592 - 214->703; // weight: 0.01318 - 214->704; // weight: -0.06592 - 214->719; // weight: -0.1187 - 214->720; // weight: 0.5933 - 214->721; // weight: -0.1187 - 214->722; // weight: 0.5933 - 215->390; // weight: 0.004578 - 215->558; // weight: 0.001526 - 215->636; // weight: 0.01373 - 215->1778; // weight: 0.004578 - 215->711; // weight: -0.02472 - 215->712; // weight: 0.1236 - 215->715; // weight: -0.008240 - 215->716; // weight: 0.04120 - 215->695; // weight: 0.04120 - 215->696; // weight: -0.008240 - 215->703; // weight: 0.1236 - 215->704; // weight: -0.02472 - 215->719; // weight: -0.2225 - 215->720; // weight: 0.04449 - 215->721; // weight: 1.112 - 215->722; // weight: -0.2225 - 216->390; // weight: -0.002441 - 216->558; // weight: -0.002441 - 216->636; // weight: -0.007324 - 216->1778; // weight: -0.007324 - 216->711; // weight: 0.01318 - 216->712; // weight: -0.06592 - 216->715; // weight: 0.01318 - 216->716; // weight: -0.06592 - 216->695; // weight: 0.02197 - 216->696; // weight: 0.02197 - 216->703; // weight: 0.06592 - 216->704; // weight: 0.06592 - 216->719; // weight: -0.1187 - 216->720; // weight: -0.1187 - 216->721; // weight: 0.5933 - 216->722; // weight: 0.5933 - 217->390; // weight: 0.001526 - 217->558; // weight: 0.004578 - 217->636; // weight: 0.004578 - 217->1778; // weight: 0.01373 - 217->711; // weight: -0.008240 - 217->712; // weight: 0.04120 - 217->715; // weight: -0.02472 - 217->716; // weight: 0.1236 - 217->695; // weight: -0.008240 - 217->696; // weight: 0.04120 - 217->703; // weight: -0.02472 - 217->704; // weight: 0.1236 - 217->719; // weight: 0.04449 - 217->720; // weight: -0.2225 - 217->721; // weight: -0.2225 - 217->722; // weight: 1.112 - 48->636; // weight: 0.1172 - 48->1215; // weight: 0.03906 - 48->707; // weight: 1.055 - 48->708; // weight: -0.2109 - 60->476; // weight: 0.1172 - 60->1215; // weight: 0.03906 - 60->713; // weight: 1.055 - 60->714; // weight: -0.2109 - 88->390; // weight: 0.01373 - 88->636; // weight: 0.004578 - 88->476; // weight: 0.004578 - 88->1215; // weight: 0.001526 - 88->699; // weight: 0.1236 - 88->700; // weight: -0.02472 - 88->707; // weight: 0.04120 - 88->708; // weight: -0.008240 - 88->711; // weight: 0.1236 - 88->712; // weight: -0.02472 - 88->713; // weight: 0.04120 - 88->714; // weight: -0.008240 - 88->727; // weight: 1.112 - 88->728; // weight: -0.2225 - 88->729; // weight: -0.2225 - 88->730; // weight: 0.04449 - 89->390; // weight: -0.007324 - 89->636; // weight: -0.007324 - 89->476; // weight: -0.002441 - 89->1215; // weight: -0.002441 - 89->699; // weight: -0.06592 - 89->700; // weight: 0.01318 - 89->707; // weight: -0.06592 - 89->708; // weight: 0.01318 - 89->711; // weight: 0.06592 - 89->712; // weight: 0.06592 - 89->713; // weight: 0.02197 - 89->714; // weight: 0.02197 - 89->727; // weight: 0.5933 - 89->728; // weight: 0.5933 - 89->729; // weight: -0.1187 - 89->730; // weight: -0.1187 - 90->390; // weight: 0.004578 - 90->636; // weight: 0.01373 - 90->476; // weight: 0.001526 - 90->1215; // weight: 0.004578 - 90->699; // weight: 0.04120 - 90->700; // weight: -0.008240 - 90->707; // weight: 0.1236 - 90->708; // weight: -0.02472 - 90->711; // weight: -0.02472 - 90->712; // weight: 0.1236 - 90->713; // weight: -0.008240 - 90->714; // weight: 0.04120 - 90->727; // weight: -0.2225 - 90->728; // weight: 1.112 - 90->729; // weight: 0.04449 - 90->730; // weight: -0.2225 - 91->390; // weight: -0.007324 - 91->636; // weight: -0.002441 - 91->476; // weight: -0.007324 - 91->1215; // weight: -0.002441 - 91->699; // weight: 0.06592 - 91->700; // weight: 0.06592 - 91->707; // weight: 0.02197 - 91->708; // weight: 0.02197 - 91->711; // weight: -0.06592 - 91->712; // weight: 0.01318 - 91->713; // weight: -0.06592 - 91->714; // weight: 0.01318 - 91->727; // weight: 0.5933 - 91->728; // weight: -0.1187 - 91->729; // weight: 0.5933 - 91->730; // weight: -0.1187 - 92->390; // weight: 0.003906 - 92->636; // weight: 0.003906 - 92->476; // weight: 0.003906 - 92->1215; // weight: 0.003906 - 92->699; // weight: -0.03516 - 92->700; // weight: -0.03516 - 92->707; // weight: -0.03516 - 92->708; // weight: -0.03516 - 92->711; // weight: -0.03516 - 92->712; // weight: -0.03516 - 92->713; // weight: -0.03516 - 92->714; // weight: -0.03516 - 92->727; // weight: 0.3164 - 92->728; // weight: 0.3164 - 92->729; // weight: 0.3164 - 92->730; // weight: 0.3164 - 93->390; // weight: -0.002441 - 93->636; // weight: -0.007324 - 93->476; // weight: -0.002441 - 93->1215; // weight: -0.007324 - 93->699; // weight: 0.02197 - 93->700; // weight: 0.02197 - 93->707; // weight: 0.06592 - 93->708; // weight: 0.06592 - 93->711; // weight: 0.01318 - 93->712; // weight: -0.06592 - 93->713; // weight: 0.01318 - 93->714; // weight: -0.06592 - 93->727; // weight: -0.1187 - 93->728; // weight: 0.5933 - 93->729; // weight: -0.1187 - 93->730; // weight: 0.5933 - 94->390; // weight: 0.004578 - 94->636; // weight: 0.001526 - 94->476; // weight: 0.01373 - 94->1215; // weight: 0.004578 - 94->699; // weight: -0.02472 - 94->700; // weight: 0.1236 - 94->707; // weight: -0.008240 - 94->708; // weight: 0.04120 - 94->711; // weight: 0.04120 - 94->712; // weight: -0.008240 - 94->713; // weight: 0.1236 - 94->714; // weight: -0.02472 - 94->727; // weight: -0.2225 - 94->728; // weight: 0.04449 - 94->729; // weight: 1.112 - 94->730; // weight: -0.2225 - 95->390; // weight: -0.002441 - 95->636; // weight: -0.002441 - 95->476; // weight: -0.007324 - 95->1215; // weight: -0.007324 - 95->699; // weight: 0.01318 - 95->700; // weight: -0.06592 - 95->707; // weight: 0.01318 - 95->708; // weight: -0.06592 - 95->711; // weight: 0.02197 - 95->712; // weight: 0.02197 - 95->713; // weight: 0.06592 - 95->714; // weight: 0.06592 - 95->727; // weight: -0.1187 - 95->728; // weight: -0.1187 - 95->729; // weight: 0.5933 - 95->730; // weight: 0.5933 - 96->390; // weight: 0.001526 - 96->636; // weight: 0.004578 - 96->476; // weight: 0.004578 - 96->1215; // weight: 0.01373 - 96->699; // weight: -0.008240 - 96->700; // weight: 0.04120 - 96->707; // weight: -0.02472 - 96->708; // weight: 0.1236 - 96->711; // weight: -0.008240 - 96->712; // weight: 0.04120 - 96->713; // weight: -0.02472 - 96->714; // weight: 0.1236 - 96->727; // weight: 0.04449 - 96->728; // weight: -0.2225 - 96->729; // weight: -0.2225 - 96->730; // weight: 1.112 - 755->476; // weight: -0.3333 - 755->484; // weight: 0.3333 - 755->754; // weight: 1.000 - 761->1215; // weight: -0.3333 - 761->1227; // weight: 0.3333 - 761->760; // weight: 1.000 - 714->476; // weight: -0.3333 - 714->1215; // weight: 0.3333 - 714->713; // weight: 1.000 - 765->484; // weight: -0.3333 - 765->1227; // weight: 0.3333 - 765->764; // weight: 1.000 - 773->754; // weight: -0.3333 - 773->760; // weight: 0.3333 - 773->772; // weight: 1.000 - 774->713; // weight: -0.3333 - 774->764; // weight: 0.3333 - 774->772; // weight: 1.000 - 775->476; // weight: 0.1111 - 775->1215; // weight: -0.1111 - 775->484; // weight: -0.1111 - 775->1227; // weight: 0.1111 - 775->754; // weight: -0.3333 - 775->760; // weight: 0.3333 - 775->713; // weight: -0.3333 - 775->764; // weight: 0.3333 - 775->772; // weight: 1.000 - 1169->476; // weight: 0.06250 - 1169->1215; // weight: -0.03125 - 1169->484; // weight: -0.03125 - 1169->1227; // weight: 0.01562 - 1169->754; // weight: -0.2813 - 1169->760; // weight: 0.1406 - 1169->713; // weight: -0.2813 - 1169->764; // weight: 0.1406 - 1169->772; // weight: 1.266 - 1175->476; // weight: -0.04688 - 1175->1215; // weight: 0.02344 - 1175->484; // weight: 0.0078125 - 1175->1227; // weight: -0.003906 - 1175->754; // weight: -0.2109 - 1175->760; // weight: 0.1055 - 1175->713; // weight: 0.2109 - 1175->764; // weight: -0.03516 - 1175->772; // weight: 0.9492 - 1177->476; // weight: -0.04688 - 1177->1215; // weight: 0.0078125 - 1177->484; // weight: 0.02344 - 1177->1227; // weight: -0.003906 - 1177->754; // weight: 0.2109 - 1177->760; // weight: -0.03516 - 1177->713; // weight: -0.2109 - 1177->764; // weight: 0.1055 - 1177->772; // weight: 0.9492 - 1180->476; // weight: 0.03516 - 1180->1215; // weight: -0.005859 - 1180->484; // weight: -0.005859 - 1180->1227; // weight: 0.0009766 - 1180->754; // weight: 0.1582 - 1180->760; // weight: -0.02637 - 1180->713; // weight: 0.1582 - 1180->764; // weight: -0.02637 - 1180->772; // weight: 0.7119 - 1216->1215; // weight: -0.2500 - 1216->1227; // weight: 0.1250 - 1216->760; // weight: 1.125 - 1219->1215; // weight: 0.1875 - 1219->1227; // weight: -0.03125 - 1219->760; // weight: 0.8438 - 1221->476; // weight: 0.07813 - 1221->1215; // weight: -0.1172 - 1221->484; // weight: -0.03906 - 1221->1227; // weight: 0.05859 - 1221->754; // weight: -0.3516 - 1221->760; // weight: 0.5273 - 1221->713; // weight: -0.2109 - 1221->764; // weight: 0.1055 - 1221->772; // weight: 0.9492 - 1224->476; // weight: -0.05859 - 1224->1215; // weight: 0.08789 - 1224->484; // weight: 0.009766 - 1224->1227; // weight: -0.01465 - 1224->754; // weight: -0.2637 - 1224->760; // weight: 0.3955 - 1224->713; // weight: 0.1582 - 1224->764; // weight: -0.02637 - 1224->772; // weight: 0.7119 - 1184->484; // weight: -0.2500 - 1184->1227; // weight: 0.1250 - 1184->764; // weight: 1.125 - 1188->476; // weight: 0.07813 - 1188->1215; // weight: -0.03906 - 1188->484; // weight: -0.1172 - 1188->1227; // weight: 0.05859 - 1188->754; // weight: -0.2109 - 1188->760; // weight: 0.1055 - 1188->713; // weight: -0.3516 - 1188->764; // weight: 0.5273 - 1188->772; // weight: 0.9492 - 1189->484; // weight: 0.1875 - 1189->1227; // weight: -0.03125 - 1189->764; // weight: 0.8438 - 1191->476; // weight: -0.05859 - 1191->1215; // weight: 0.009766 - 1191->484; // weight: 0.08789 - 1191->1227; // weight: -0.01465 - 1191->754; // weight: 0.1582 - 1191->760; // weight: -0.02637 - 1191->713; // weight: -0.2637 - 1191->764; // weight: 0.3955 - 1191->772; // weight: 0.7119 - 1229->1215; // weight: -0.3125 - 1229->1227; // weight: 0.4688 - 1229->760; // weight: 0.8438 - 1230->484; // weight: -0.3125 - 1230->1227; // weight: 0.4688 - 1230->764; // weight: 0.8438 - 1232->476; // weight: 0.09766 - 1232->1215; // weight: -0.1465 - 1232->484; // weight: -0.1465 - 1232->1227; // weight: 0.2197 - 1232->754; // weight: -0.2637 - 1232->760; // weight: 0.3955 - 1232->713; // weight: -0.2637 - 1232->764; // weight: 0.3955 - 1232->772; // weight: 0.7119 - 753->484; // weight: -0.3333 - 753->2558; // weight: 0.3333 - 753->752; // weight: 1.000 - 757->598; // weight: -0.3333 - 757->2558; // weight: 0.3333 - 757->756; // weight: 1.000 - 781->697; // weight: -0.3333 - 781->752; // weight: 0.3333 - 781->780; // weight: 1.000 - 782->754; // weight: -0.3333 - 782->756; // weight: 0.3333 - 782->780; // weight: 1.000 - 783->476; // weight: 0.1111 - 783->484; // weight: -0.1111 - 783->598; // weight: -0.1111 - 783->2558; // weight: 0.1111 - 783->697; // weight: -0.3333 - 783->752; // weight: 0.3333 - 783->754; // weight: -0.3333 - 783->756; // weight: 0.3333 - 783->780; // weight: 1.000 - 2523->476; // weight: 0.06250 - 2523->484; // weight: -0.03125 - 2523->598; // weight: -0.03125 - 2523->2558; // weight: 0.01562 - 2523->697; // weight: -0.2813 - 2523->752; // weight: 0.1406 - 2523->754; // weight: -0.2813 - 2523->756; // weight: 0.1406 - 2523->780; // weight: 1.266 - 2525->476; // weight: -0.04688 - 2525->484; // weight: 0.02344 - 2525->598; // weight: 0.0078125 - 2525->2558; // weight: -0.003906 - 2525->697; // weight: -0.2109 - 2525->752; // weight: 0.1055 - 2525->754; // weight: 0.2109 - 2525->756; // weight: -0.03516 - 2525->780; // weight: 0.9492 - 2526->476; // weight: -0.04688 - 2526->484; // weight: 0.0078125 - 2526->598; // weight: 0.02344 - 2526->2558; // weight: -0.003906 - 2526->697; // weight: 0.2109 - 2526->752; // weight: -0.03516 - 2526->754; // weight: -0.2109 - 2526->756; // weight: 0.1055 - 2526->780; // weight: 0.9492 - 2535->476; // weight: 0.03516 - 2535->484; // weight: -0.005859 - 2535->598; // weight: -0.005859 - 2535->2558; // weight: 0.0009766 - 2535->697; // weight: 0.1582 - 2535->752; // weight: -0.02637 - 2535->754; // weight: 0.1582 - 2535->756; // weight: -0.02637 - 2535->780; // weight: 0.7119 - 2537->484; // weight: -0.2500 - 2537->2558; // weight: 0.1250 - 2537->752; // weight: 1.125 - 2538->484; // weight: 0.1875 - 2538->2558; // weight: -0.03125 - 2538->752; // weight: 0.8438 - 2539->476; // weight: 0.07813 - 2539->484; // weight: -0.1172 - 2539->598; // weight: -0.03906 - 2539->2558; // weight: 0.05859 - 2539->697; // weight: -0.3516 - 2539->752; // weight: 0.5273 - 2539->754; // weight: -0.2109 - 2539->756; // weight: 0.1055 - 2539->780; // weight: 0.9492 - 2545->476; // weight: -0.05859 - 2545->484; // weight: 0.08789 - 2545->598; // weight: 0.009766 - 2545->2558; // weight: -0.01465 - 2545->697; // weight: -0.2637 - 2545->752; // weight: 0.3955 - 2545->754; // weight: 0.1582 - 2545->756; // weight: -0.02637 - 2545->780; // weight: 0.7119 - 2547->598; // weight: -0.2500 - 2547->2558; // weight: 0.1250 - 2547->756; // weight: 1.125 - 2549->476; // weight: 0.07813 - 2549->484; // weight: -0.03906 - 2549->598; // weight: -0.1172 - 2549->2558; // weight: 0.05859 - 2549->697; // weight: -0.2109 - 2549->752; // weight: 0.1055 - 2549->754; // weight: -0.3516 - 2549->756; // weight: 0.5273 - 2549->780; // weight: 0.9492 - 2550->598; // weight: 0.1875 - 2550->2558; // weight: -0.03125 - 2550->756; // weight: 0.8438 - 2556->476; // weight: -0.05859 - 2556->484; // weight: 0.009766 - 2556->598; // weight: 0.08789 - 2556->2558; // weight: -0.01465 - 2556->697; // weight: 0.1582 - 2556->752; // weight: -0.02637 - 2556->754; // weight: -0.2637 - 2556->756; // weight: 0.3955 - 2556->780; // weight: 0.7119 - 2559->484; // weight: -0.3125 - 2559->2558; // weight: 0.4688 - 2559->752; // weight: 0.8438 - 2560->598; // weight: -0.3125 - 2560->2558; // weight: 0.4688 - 2560->756; // weight: 0.8438 - 2564->476; // weight: 0.09766 - 2564->484; // weight: -0.1465 - 2564->598; // weight: -0.1465 - 2564->2558; // weight: 0.2197 - 2564->697; // weight: -0.2637 - 2564->752; // weight: 0.3955 - 2564->754; // weight: -0.2637 - 2564->756; // weight: 0.3955 - 2564->780; // weight: 0.7119 - 716->558; // weight: -0.3333 - 716->1778; // weight: 0.3333 - 716->715; // weight: 1.000 - 810->578; // weight: -0.3333 - 810->1798; // weight: 0.3333 - 810->809; // weight: 1.000 - 798->558; // weight: -0.3333 - 798->578; // weight: 0.3333 - 798->797; // weight: 1.000 - 804->1778; // weight: -0.3333 - 804->1798; // weight: 0.3333 - 804->803; // weight: 1.000 - 814->715; // weight: -0.3333 - 814->809; // weight: 0.3333 - 814->813; // weight: 1.000 - 815->797; // weight: -0.3333 - 815->803; // weight: 0.3333 - 815->813; // weight: 1.000 - 816->558; // weight: 0.1111 - 816->578; // weight: -0.1111 - 816->1778; // weight: -0.1111 - 816->1798; // weight: 0.1111 - 816->715; // weight: -0.3333 - 816->809; // weight: 0.3333 - 816->797; // weight: -0.3333 - 816->803; // weight: 0.3333 - 816->813; // weight: 1.000 - 1728->558; // weight: 0.06250 - 1728->578; // weight: -0.03125 - 1728->1778; // weight: -0.03125 - 1728->1798; // weight: 0.01562 - 1728->715; // weight: -0.2813 - 1728->809; // weight: 0.1406 - 1728->797; // weight: -0.2813 - 1728->803; // weight: 0.1406 - 1728->813; // weight: 1.266 - 1736->558; // weight: -0.04688 - 1736->578; // weight: 0.02344 - 1736->1778; // weight: 0.0078125 - 1736->1798; // weight: -0.003906 - 1736->715; // weight: -0.2109 - 1736->809; // weight: 0.1055 - 1736->797; // weight: 0.2109 - 1736->803; // weight: -0.03516 - 1736->813; // weight: 0.9492 - 1732->558; // weight: -0.04688 - 1732->578; // weight: 0.0078125 - 1732->1778; // weight: 0.02344 - 1732->1798; // weight: -0.003906 - 1732->715; // weight: 0.2109 - 1732->809; // weight: -0.03516 - 1732->797; // weight: -0.2109 - 1732->803; // weight: 0.1055 - 1732->813; // weight: 0.9492 - 1737->558; // weight: 0.03516 - 1737->578; // weight: -0.005859 - 1737->1778; // weight: -0.005859 - 1737->1798; // weight: 0.0009766 - 1737->715; // weight: 0.1582 - 1737->809; // weight: -0.02637 - 1737->797; // weight: 0.1582 - 1737->803; // weight: -0.02637 - 1737->813; // weight: 0.7119 - 1755->578; // weight: -0.2500 - 1755->1798; // weight: 0.1250 - 1755->809; // weight: 1.125 - 1760->578; // weight: 0.1875 - 1760->1798; // weight: -0.03125 - 1760->809; // weight: 0.8438 - 1758->558; // weight: 0.07813 - 1758->578; // weight: -0.1172 - 1758->1778; // weight: -0.03906 - 1758->1798; // weight: 0.05859 - 1758->715; // weight: -0.3516 - 1758->809; // weight: 0.5273 - 1758->797; // weight: -0.2109 - 1758->803; // weight: 0.1055 - 1758->813; // weight: 0.9492 - 1761->558; // weight: -0.05859 - 1761->578; // weight: 0.08789 - 1761->1778; // weight: 0.009766 - 1761->1798; // weight: -0.01465 - 1761->715; // weight: -0.2637 - 1761->809; // weight: 0.3955 - 1761->797; // weight: 0.1582 - 1761->803; // weight: -0.02637 - 1761->813; // weight: 0.7119 - 1779->1778; // weight: -0.2500 - 1779->1798; // weight: 0.1250 - 1779->803; // weight: 1.125 - 1784->558; // weight: 0.07813 - 1784->578; // weight: -0.03906 - 1784->1778; // weight: -0.1172 - 1784->1798; // weight: 0.05859 - 1784->715; // weight: -0.2109 - 1784->809; // weight: 0.1055 - 1784->797; // weight: -0.3516 - 1784->803; // weight: 0.5273 - 1784->813; // weight: 0.9492 - 1780->1778; // weight: 0.1875 - 1780->1798; // weight: -0.03125 - 1780->803; // weight: 0.8438 - 1785->558; // weight: -0.05859 - 1785->578; // weight: 0.009766 - 1785->1778; // weight: 0.08789 - 1785->1798; // weight: -0.01465 - 1785->715; // weight: 0.1582 - 1785->809; // weight: -0.02637 - 1785->797; // weight: -0.2637 - 1785->803; // weight: 0.3955 - 1785->813; // weight: 0.7119 - 1801->578; // weight: -0.3125 - 1801->1798; // weight: 0.4688 - 1801->809; // weight: 0.8438 - 1799->1778; // weight: -0.3125 - 1799->1798; // weight: 0.4688 - 1799->803; // weight: 0.8438 - 1802->558; // weight: 0.09766 - 1802->578; // weight: -0.1465 - 1802->1778; // weight: -0.1465 - 1802->1798; // weight: 0.2197 - 1802->715; // weight: -0.2637 - 1802->809; // weight: 0.3955 - 1802->797; // weight: -0.2637 - 1802->803; // weight: 0.3955 - 1802->813; // weight: 0.7119 - 800->598; // weight: -0.3333 - 800->2649; // weight: 0.3333 - 800->799; // weight: 1.000 - 802->578; // weight: -0.3333 - 802->2649; // weight: 0.3333 - 802->801; // weight: 1.000 - 826->797; // weight: -0.3333 - 826->799; // weight: 0.3333 - 826->825; // weight: 1.000 - 827->701; // weight: -0.3333 - 827->801; // weight: 0.3333 - 827->825; // weight: 1.000 - 828->558; // weight: 0.1111 - 828->598; // weight: -0.1111 - 828->578; // weight: -0.1111 - 828->2649; // weight: 0.1111 - 828->797; // weight: -0.3333 - 828->799; // weight: 0.3333 - 828->701; // weight: -0.3333 - 828->801; // weight: 0.3333 - 828->825; // weight: 1.000 - 2615->558; // weight: 0.06250 - 2615->598; // weight: -0.03125 - 2615->578; // weight: -0.03125 - 2615->2649; // weight: 0.01562 - 2615->797; // weight: -0.2813 - 2615->799; // weight: 0.1406 - 2615->701; // weight: -0.2813 - 2615->801; // weight: 0.1406 - 2615->825; // weight: 1.266 - 2616->558; // weight: -0.04688 - 2616->598; // weight: 0.02344 - 2616->578; // weight: 0.0078125 - 2616->2649; // weight: -0.003906 - 2616->797; // weight: -0.2109 - 2616->799; // weight: 0.1055 - 2616->701; // weight: 0.2109 - 2616->801; // weight: -0.03516 - 2616->825; // weight: 0.9492 - 2618->558; // weight: -0.04688 - 2618->598; // weight: 0.0078125 - 2618->578; // weight: 0.02344 - 2618->2649; // weight: -0.003906 - 2618->797; // weight: 0.2109 - 2618->799; // weight: -0.03516 - 2618->701; // weight: -0.2109 - 2618->801; // weight: 0.1055 - 2618->825; // weight: 0.9492 - 2627->558; // weight: 0.03516 - 2627->598; // weight: -0.005859 - 2627->578; // weight: -0.005859 - 2627->2649; // weight: 0.0009766 - 2627->797; // weight: 0.1582 - 2627->799; // weight: -0.02637 - 2627->701; // weight: 0.1582 - 2627->801; // weight: -0.02637 - 2627->825; // weight: 0.7119 - 2629->598; // weight: -0.2500 - 2629->2649; // weight: 0.1250 - 2629->799; // weight: 1.125 - 2630->598; // weight: 0.1875 - 2630->2649; // weight: -0.03125 - 2630->799; // weight: 0.8438 - 2632->558; // weight: 0.07813 - 2632->598; // weight: -0.1172 - 2632->578; // weight: -0.03906 - 2632->2649; // weight: 0.05859 - 2632->797; // weight: -0.3516 - 2632->799; // weight: 0.5273 - 2632->701; // weight: -0.2109 - 2632->801; // weight: 0.1055 - 2632->825; // weight: 0.9492 - 2637->558; // weight: -0.05859 - 2637->598; // weight: 0.08789 - 2637->578; // weight: 0.009766 - 2637->2649; // weight: -0.01465 - 2637->797; // weight: -0.2637 - 2637->799; // weight: 0.3955 - 2637->701; // weight: 0.1582 - 2637->801; // weight: -0.02637 - 2637->825; // weight: 0.7119 - 2639->578; // weight: -0.2500 - 2639->2649; // weight: 0.1250 - 2639->801; // weight: 1.125 - 2640->558; // weight: 0.07813 - 2640->598; // weight: -0.03906 - 2640->578; // weight: -0.1172 - 2640->2649; // weight: 0.05859 - 2640->797; // weight: -0.2109 - 2640->799; // weight: 0.1055 - 2640->701; // weight: -0.3516 - 2640->801; // weight: 0.5273 - 2640->825; // weight: 0.9492 - 2641->578; // weight: 0.1875 - 2641->2649; // weight: -0.03125 - 2641->801; // weight: 0.8438 - 2647->558; // weight: -0.05859 - 2647->598; // weight: 0.009766 - 2647->578; // weight: 0.08789 - 2647->2649; // weight: -0.01465 - 2647->797; // weight: 0.1582 - 2647->799; // weight: -0.02637 - 2647->701; // weight: -0.2637 - 2647->801; // weight: 0.3955 - 2647->825; // weight: 0.7119 - 2650->598; // weight: -0.3125 - 2650->2649; // weight: 0.4688 - 2650->799; // weight: 0.8438 - 2651->578; // weight: -0.3125 - 2651->2649; // weight: 0.4688 - 2651->801; // weight: 0.8438 - 2655->558; // weight: 0.09766 - 2655->598; // weight: -0.1465 - 2655->578; // weight: -0.1465 - 2655->2649; // weight: 0.2197 - 2655->797; // weight: -0.2637 - 2655->799; // weight: 0.3955 - 2655->701; // weight: -0.2637 - 2655->801; // weight: 0.3955 - 2655->825; // weight: 0.7119 - 843->2558; // weight: -0.3333 - 843->2713; // weight: 0.3333 - 843->842; // weight: 1.000 - 845->2649; // weight: -0.3333 - 845->2713; // weight: 0.3333 - 845->844; // weight: 1.000 - 861->799; // weight: -0.3333 - 861->842; // weight: 0.3333 - 861->860; // weight: 1.000 - 862->756; // weight: -0.3333 - 862->844; // weight: 0.3333 - 862->860; // weight: 1.000 - 863->598; // weight: 0.1111 - 863->2558; // weight: -0.1111 - 863->2649; // weight: -0.1111 - 863->2713; // weight: 0.1111 - 863->799; // weight: -0.3333 - 863->842; // weight: 0.3333 - 863->756; // weight: -0.3333 - 863->844; // weight: 0.3333 - 863->860; // weight: 1.000 - 2689->598; // weight: 0.06250 - 2689->2558; // weight: -0.03125 - 2689->2649; // weight: -0.03125 - 2689->2713; // weight: 0.01562 - 2689->799; // weight: -0.2813 - 2689->842; // weight: 0.1406 - 2689->756; // weight: -0.2813 - 2689->844; // weight: 0.1406 - 2689->860; // weight: 1.266 - 2690->598; // weight: -0.04688 - 2690->2558; // weight: 0.02344 - 2690->2649; // weight: 0.0078125 - 2690->2713; // weight: -0.003906 - 2690->799; // weight: -0.2109 - 2690->842; // weight: 0.1055 - 2690->756; // weight: 0.2109 - 2690->844; // weight: -0.03516 - 2690->860; // weight: 0.9492 - 2691->598; // weight: -0.04688 - 2691->2558; // weight: 0.0078125 - 2691->2649; // weight: 0.02344 - 2691->2713; // weight: -0.003906 - 2691->799; // weight: 0.2109 - 2691->842; // weight: -0.03516 - 2691->756; // weight: -0.2109 - 2691->844; // weight: 0.1055 - 2691->860; // weight: 0.9492 - 2695->598; // weight: 0.03516 - 2695->2558; // weight: -0.005859 - 2695->2649; // weight: -0.005859 - 2695->2713; // weight: 0.0009766 - 2695->799; // weight: 0.1582 - 2695->842; // weight: -0.02637 - 2695->756; // weight: 0.1582 - 2695->844; // weight: -0.02637 - 2695->860; // weight: 0.7119 - 2697->2558; // weight: -0.2500 - 2697->2713; // weight: 0.1250 - 2697->842; // weight: 1.125 - 2698->2558; // weight: 0.1875 - 2698->2713; // weight: -0.03125 - 2698->842; // weight: 0.8438 - 2699->598; // weight: 0.07813 - 2699->2558; // weight: -0.1172 - 2699->2649; // weight: -0.03906 - 2699->2713; // weight: 0.05859 - 2699->799; // weight: -0.3516 - 2699->842; // weight: 0.5273 - 2699->756; // weight: -0.2109 - 2699->844; // weight: 0.1055 - 2699->860; // weight: 0.9492 - 2703->598; // weight: -0.05859 - 2703->2558; // weight: 0.08789 - 2703->2649; // weight: 0.009766 - 2703->2713; // weight: -0.01465 - 2703->799; // weight: -0.2637 - 2703->842; // weight: 0.3955 - 2703->756; // weight: 0.1582 - 2703->844; // weight: -0.02637 - 2703->860; // weight: 0.7119 - 2705->2649; // weight: -0.2500 - 2705->2713; // weight: 0.1250 - 2705->844; // weight: 1.125 - 2706->598; // weight: 0.07813 - 2706->2558; // weight: -0.03906 - 2706->2649; // weight: -0.1172 - 2706->2713; // weight: 0.05859 - 2706->799; // weight: -0.2109 - 2706->842; // weight: 0.1055 - 2706->756; // weight: -0.3516 - 2706->844; // weight: 0.5273 - 2706->860; // weight: 0.9492 - 2707->2649; // weight: 0.1875 - 2707->2713; // weight: -0.03125 - 2707->844; // weight: 0.8438 - 2711->598; // weight: -0.05859 - 2711->2558; // weight: 0.009766 - 2711->2649; // weight: 0.08789 - 2711->2713; // weight: -0.01465 - 2711->799; // weight: 0.1582 - 2711->842; // weight: -0.02637 - 2711->756; // weight: -0.2637 - 2711->844; // weight: 0.3955 - 2711->860; // weight: 0.7119 - 2714->2558; // weight: -0.3125 - 2714->2713; // weight: 0.4688 - 2714->842; // weight: 0.8438 - 2715->2649; // weight: -0.3125 - 2715->2713; // weight: 0.4688 - 2715->844; // weight: 0.8438 - 2719->598; // weight: 0.09766 - 2719->2558; // weight: -0.1465 - 2719->2649; // weight: -0.1465 - 2719->2713; // weight: 0.2197 - 2719->799; // weight: -0.2637 - 2719->842; // weight: 0.3955 - 2719->756; // weight: -0.2637 - 2719->844; // weight: 0.3955 - 2719->860; // weight: 0.7119 - 886->636; // weight: -0.3333 - 886->686; // weight: 0.3333 - 886->885; // weight: 1.000 - 890->1778; // weight: -0.3333 - 890->2005; // weight: 0.3333 - 890->889; // weight: 1.000 - 704->636; // weight: -0.3333 - 704->1778; // weight: 0.3333 - 704->703; // weight: 1.000 - 878->686; // weight: -0.3333 - 878->2005; // weight: 0.3333 - 878->877; // weight: 1.000 - 894->885; // weight: -0.3333 - 894->889; // weight: 0.3333 - 894->893; // weight: 1.000 - 895->703; // weight: -0.3333 - 895->877; // weight: 0.3333 - 895->893; // weight: 1.000 - 896->636; // weight: 0.1111 - 896->1778; // weight: -0.1111 - 896->686; // weight: -0.1111 - 896->2005; // weight: 0.1111 - 896->885; // weight: -0.3333 - 896->889; // weight: 0.3333 - 896->703; // weight: -0.3333 - 896->877; // weight: 0.3333 - 896->893; // weight: 1.000 - 1941->636; // weight: 0.06250 - 1941->1778; // weight: -0.03125 - 1941->686; // weight: -0.03125 - 1941->2005; // weight: 0.01562 - 1941->885; // weight: -0.2813 - 1941->889; // weight: 0.1406 - 1941->703; // weight: -0.2813 - 1941->877; // weight: 0.1406 - 1941->893; // weight: 1.266 - 1948->636; // weight: -0.04688 - 1948->1778; // weight: 0.02344 - 1948->686; // weight: 0.0078125 - 1948->2005; // weight: -0.003906 - 1948->885; // weight: -0.2109 - 1948->889; // weight: 0.1055 - 1948->703; // weight: 0.2109 - 1948->877; // weight: -0.03516 - 1948->893; // weight: 0.9492 - 1945->636; // weight: -0.04688 - 1945->1778; // weight: 0.0078125 - 1945->686; // weight: 0.02344 - 1945->2005; // weight: -0.003906 - 1945->885; // weight: 0.2109 - 1945->889; // weight: -0.03516 - 1945->703; // weight: -0.2109 - 1945->877; // weight: 0.1055 - 1945->893; // weight: 0.9492 - 1949->636; // weight: 0.03516 - 1949->1778; // weight: -0.005859 - 1949->686; // weight: -0.005859 - 1949->2005; // weight: 0.0009766 - 1949->885; // weight: 0.1582 - 1949->889; // weight: -0.02637 - 1949->703; // weight: 0.1582 - 1949->877; // weight: -0.02637 - 1949->893; // weight: 0.7119 - 1965->1778; // weight: -0.2500 - 1965->2005; // weight: 0.1250 - 1965->889; // weight: 1.125 - 1969->1778; // weight: 0.1875 - 1969->2005; // weight: -0.03125 - 1969->889; // weight: 0.8438 - 1967->636; // weight: 0.07813 - 1967->1778; // weight: -0.1172 - 1967->686; // weight: -0.03906 - 1967->2005; // weight: 0.05859 - 1967->885; // weight: -0.3516 - 1967->889; // weight: 0.5273 - 1967->703; // weight: -0.2109 - 1967->877; // weight: 0.1055 - 1967->893; // weight: 0.9492 - 1970->636; // weight: -0.05859 - 1970->1778; // weight: 0.08789 - 1970->686; // weight: 0.009766 - 1970->2005; // weight: -0.01465 - 1970->885; // weight: -0.2637 - 1970->889; // weight: 0.3955 - 1970->703; // weight: 0.1582 - 1970->877; // weight: -0.02637 - 1970->893; // weight: 0.7119 - 1987->686; // weight: -0.2500 - 1987->2005; // weight: 0.1250 - 1987->877; // weight: 1.125 - 1991->636; // weight: 0.07813 - 1991->1778; // weight: -0.03906 - 1991->686; // weight: -0.1172 - 1991->2005; // weight: 0.05859 - 1991->885; // weight: -0.2109 - 1991->889; // weight: 0.1055 - 1991->703; // weight: -0.3516 - 1991->877; // weight: 0.5273 - 1991->893; // weight: 0.9492 - 1988->686; // weight: 0.1875 - 1988->2005; // weight: -0.03125 - 1988->877; // weight: 0.8438 - 1992->636; // weight: -0.05859 - 1992->1778; // weight: 0.009766 - 1992->686; // weight: 0.08789 - 1992->2005; // weight: -0.01465 - 1992->885; // weight: 0.1582 - 1992->889; // weight: -0.02637 - 1992->703; // weight: -0.2637 - 1992->877; // weight: 0.3955 - 1992->893; // weight: 0.7119 - 2008->1778; // weight: -0.3125 - 2008->2005; // weight: 0.4688 - 2008->889; // weight: 0.8438 - 2006->686; // weight: -0.3125 - 2006->2005; // weight: 0.4688 - 2006->877; // weight: 0.8438 - 2009->636; // weight: 0.09766 - 2009->1778; // weight: -0.1465 - 2009->686; // weight: -0.1465 - 2009->2005; // weight: 0.2197 - 2009->885; // weight: -0.2637 - 2009->889; // weight: 0.3955 - 2009->703; // weight: -0.2637 - 2009->877; // weight: 0.3955 - 2009->893; // weight: 0.7119 - 708->636; // weight: -0.3333 - 708->1215; // weight: 0.3333 - 708->707; // weight: 1.000 - 882->686; // weight: -0.3333 - 882->1517; // weight: 0.3333 - 882->881; // weight: 1.000 - 888->1215; // weight: -0.3333 - 888->1517; // weight: 0.3333 - 888->887; // weight: 1.000 - 902->707; // weight: -0.3333 - 902->881; // weight: 0.3333 - 902->901; // weight: 1.000 - 903->885; // weight: -0.3333 - 903->887; // weight: 0.3333 - 903->901; // weight: 1.000 - 904->636; // weight: 0.1111 - 904->686; // weight: -0.1111 - 904->1215; // weight: -0.1111 - 904->1517; // weight: 0.1111 - 904->707; // weight: -0.3333 - 904->881; // weight: 0.3333 - 904->885; // weight: -0.3333 - 904->887; // weight: 0.3333 - 904->901; // weight: 1.000 - 1461->636; // weight: 0.06250 - 1461->686; // weight: -0.03125 - 1461->1215; // weight: -0.03125 - 1461->1517; // weight: 0.01562 - 1461->707; // weight: -0.2813 - 1461->881; // weight: 0.1406 - 1461->885; // weight: -0.2813 - 1461->887; // weight: 0.1406 - 1461->901; // weight: 1.266 - 1467->636; // weight: -0.04688 - 1467->686; // weight: 0.02344 - 1467->1215; // weight: 0.0078125 - 1467->1517; // weight: -0.003906 - 1467->707; // weight: -0.2109 - 1467->881; // weight: 0.1055 - 1467->885; // weight: 0.2109 - 1467->887; // weight: -0.03516 - 1467->901; // weight: 0.9492 - 1469->636; // weight: -0.04688 - 1469->686; // weight: 0.0078125 - 1469->1215; // weight: 0.02344 - 1469->1517; // weight: -0.003906 - 1469->707; // weight: 0.2109 - 1469->881; // weight: -0.03516 - 1469->885; // weight: -0.2109 - 1469->887; // weight: 0.1055 - 1469->901; // weight: 0.9492 - 1472->636; // weight: 0.03516 - 1472->686; // weight: -0.005859 - 1472->1215; // weight: -0.005859 - 1472->1517; // weight: 0.0009766 - 1472->707; // weight: 0.1582 - 1472->881; // weight: -0.02637 - 1472->885; // weight: 0.1582 - 1472->887; // weight: -0.02637 - 1472->901; // weight: 0.7119 - 1506->686; // weight: -0.2500 - 1506->1517; // weight: 0.1250 - 1506->881; // weight: 1.125 - 1509->686; // weight: 0.1875 - 1509->1517; // weight: -0.03125 - 1509->881; // weight: 0.8438 - 1511->636; // weight: 0.07813 - 1511->686; // weight: -0.1172 - 1511->1215; // weight: -0.03906 - 1511->1517; // weight: 0.05859 - 1511->707; // weight: -0.3516 - 1511->881; // weight: 0.5273 - 1511->885; // weight: -0.2109 - 1511->887; // weight: 0.1055 - 1511->901; // weight: 0.9492 - 1514->636; // weight: -0.05859 - 1514->686; // weight: 0.08789 - 1514->1215; // weight: 0.009766 - 1514->1517; // weight: -0.01465 - 1514->707; // weight: -0.2637 - 1514->881; // weight: 0.3955 - 1514->885; // weight: 0.1582 - 1514->887; // weight: -0.02637 - 1514->901; // weight: 0.7119 - 1476->1215; // weight: -0.2500 - 1476->1517; // weight: 0.1250 - 1476->887; // weight: 1.125 - 1479->636; // weight: 0.07813 - 1479->686; // weight: -0.03906 - 1479->1215; // weight: -0.1172 - 1479->1517; // weight: 0.05859 - 1479->707; // weight: -0.2109 - 1479->881; // weight: 0.1055 - 1479->885; // weight: -0.3516 - 1479->887; // weight: 0.5273 - 1479->901; // weight: 0.9492 - 1480->1215; // weight: 0.1875 - 1480->1517; // weight: -0.03125 - 1480->887; // weight: 0.8438 - 1482->636; // weight: -0.05859 - 1482->686; // weight: 0.009766 - 1482->1215; // weight: 0.08789 - 1482->1517; // weight: -0.01465 - 1482->707; // weight: 0.1582 - 1482->881; // weight: -0.02637 - 1482->885; // weight: -0.2637 - 1482->887; // weight: 0.3955 - 1482->901; // weight: 0.7119 - 1519->686; // weight: -0.3125 - 1519->1517; // weight: 0.4688 - 1519->881; // weight: 0.8438 - 1520->1215; // weight: -0.3125 - 1520->1517; // weight: 0.4688 - 1520->887; // weight: 0.8438 - 1522->636; // weight: 0.09766 - 1522->686; // weight: -0.1465 - 1522->1215; // weight: -0.1465 - 1522->1517; // weight: 0.2197 - 1522->707; // weight: -0.2637 - 1522->881; // weight: 0.3955 - 1522->885; // weight: -0.2637 - 1522->887; // weight: 0.3955 - 1522->901; // weight: 0.7119 - 925->1517; // weight: -0.3333 - 925->1581; // weight: 0.3333 - 925->924; // weight: 1.000 - 929->1227; // weight: -0.3333 - 929->1581; // weight: 0.3333 - 929->928; // weight: 1.000 - 937->760; // weight: -0.3333 - 937->924; // weight: 0.3333 - 937->936; // weight: 1.000 - 938->887; // weight: -0.3333 - 938->928; // weight: 0.3333 - 938->936; // weight: 1.000 - 939->1215; // weight: 0.1111 - 939->1517; // weight: -0.1111 - 939->1227; // weight: -0.1111 - 939->1581; // weight: 0.1111 - 939->760; // weight: -0.3333 - 939->924; // weight: 0.3333 - 939->887; // weight: -0.3333 - 939->928; // weight: 0.3333 - 939->936; // weight: 1.000 - 1541->1215; // weight: 0.06250 - 1541->1517; // weight: -0.03125 - 1541->1227; // weight: -0.03125 - 1541->1581; // weight: 0.01562 - 1541->760; // weight: -0.2813 - 1541->924; // weight: 0.1406 - 1541->887; // weight: -0.2813 - 1541->928; // weight: 0.1406 - 1541->936; // weight: 1.266 - 1543->1215; // weight: -0.04688 - 1543->1517; // weight: 0.02344 - 1543->1227; // weight: 0.0078125 - 1543->1581; // weight: -0.003906 - 1543->760; // weight: -0.2109 - 1543->924; // weight: 0.1055 - 1543->887; // weight: 0.2109 - 1543->928; // weight: -0.03516 - 1543->936; // weight: 0.9492 - 1544->1215; // weight: -0.04688 - 1544->1517; // weight: 0.0078125 - 1544->1227; // weight: 0.02344 - 1544->1581; // weight: -0.003906 - 1544->760; // weight: 0.2109 - 1544->924; // weight: -0.03516 - 1544->887; // weight: -0.2109 - 1544->928; // weight: 0.1055 - 1544->936; // weight: 0.9492 - 1546->1215; // weight: 0.03516 - 1546->1517; // weight: -0.005859 - 1546->1227; // weight: -0.005859 - 1546->1581; // weight: 0.0009766 - 1546->760; // weight: 0.1582 - 1546->924; // weight: -0.02637 - 1546->887; // weight: 0.1582 - 1546->928; // weight: -0.02637 - 1546->936; // weight: 0.7119 - 1573->1517; // weight: -0.2500 - 1573->1581; // weight: 0.1250 - 1573->924; // weight: 1.125 - 1575->1517; // weight: 0.1875 - 1575->1581; // weight: -0.03125 - 1575->924; // weight: 0.8438 - 1576->1215; // weight: 0.07813 - 1576->1517; // weight: -0.1172 - 1576->1227; // weight: -0.03906 - 1576->1581; // weight: 0.05859 - 1576->760; // weight: -0.3516 - 1576->924; // weight: 0.5273 - 1576->887; // weight: -0.2109 - 1576->928; // weight: 0.1055 - 1576->936; // weight: 0.9492 - 1578->1215; // weight: -0.05859 - 1578->1517; // weight: 0.08789 - 1578->1227; // weight: 0.009766 - 1578->1581; // weight: -0.01465 - 1578->760; // weight: -0.2637 - 1578->924; // weight: 0.3955 - 1578->887; // weight: 0.1582 - 1578->928; // weight: -0.02637 - 1578->936; // weight: 0.7119 - 1549->1227; // weight: -0.2500 - 1549->1581; // weight: 0.1250 - 1549->928; // weight: 1.125 - 1551->1215; // weight: 0.07813 - 1551->1517; // weight: -0.03906 - 1551->1227; // weight: -0.1172 - 1551->1581; // weight: 0.05859 - 1551->760; // weight: -0.2109 - 1551->924; // weight: 0.1055 - 1551->887; // weight: -0.3516 - 1551->928; // weight: 0.5273 - 1551->936; // weight: 0.9492 - 1552->1227; // weight: 0.1875 - 1552->1581; // weight: -0.03125 - 1552->928; // weight: 0.8438 - 1554->1215; // weight: -0.05859 - 1554->1517; // weight: 0.009766 - 1554->1227; // weight: 0.08789 - 1554->1581; // weight: -0.01465 - 1554->760; // weight: 0.1582 - 1554->924; // weight: -0.02637 - 1554->887; // weight: -0.2637 - 1554->928; // weight: 0.3955 - 1554->936; // weight: 0.7119 - 1583->1517; // weight: -0.3125 - 1583->1581; // weight: 0.4688 - 1583->924; // weight: 0.8438 - 1584->1227; // weight: -0.3125 - 1584->1581; // weight: 0.4688 - 1584->928; // weight: 0.8438 - 1586->1215; // weight: 0.09766 - 1586->1517; // weight: -0.1465 - 1586->1227; // weight: -0.1465 - 1586->1581; // weight: 0.2197 - 1586->760; // weight: -0.2637 - 1586->924; // weight: 0.3955 - 1586->887; // weight: -0.2637 - 1586->928; // weight: 0.3955 - 1586->936; // weight: 0.7119 - 964->1798; // weight: -0.3333 - 964->2149; // weight: 0.3333 - 964->963; // weight: 1.000 - 958->2005; // weight: -0.3333 - 958->2149; // weight: 0.3333 - 958->957; // weight: 1.000 - 968->889; // weight: -0.3333 - 968->963; // weight: 0.3333 - 968->967; // weight: 1.000 - 969->803; // weight: -0.3333 - 969->957; // weight: 0.3333 - 969->967; // weight: 1.000 - 970->1778; // weight: 0.1111 - 970->1798; // weight: -0.1111 - 970->2005; // weight: -0.1111 - 970->2149; // weight: 0.1111 - 970->889; // weight: -0.3333 - 970->963; // weight: 0.3333 - 970->803; // weight: -0.3333 - 970->957; // weight: 0.3333 - 970->967; // weight: 1.000 - 2101->1778; // weight: 0.06250 - 2101->1798; // weight: -0.03125 - 2101->2005; // weight: -0.03125 - 2101->2149; // weight: 0.01562 - 2101->889; // weight: -0.2813 - 2101->963; // weight: 0.1406 - 2101->803; // weight: -0.2813 - 2101->957; // weight: 0.1406 - 2101->967; // weight: 1.266 - 2104->1778; // weight: -0.04688 - 2104->1798; // weight: 0.02344 - 2104->2005; // weight: 0.0078125 - 2104->2149; // weight: -0.003906 - 2104->889; // weight: -0.2109 - 2104->963; // weight: 0.1055 - 2104->803; // weight: 0.2109 - 2104->957; // weight: -0.03516 - 2104->967; // weight: 0.9492 - 2102->1778; // weight: -0.04688 - 2102->1798; // weight: 0.0078125 - 2102->2005; // weight: 0.02344 - 2102->2149; // weight: -0.003906 - 2102->889; // weight: 0.2109 - 2102->963; // weight: -0.03516 - 2102->803; // weight: -0.2109 - 2102->957; // weight: 0.1055 - 2102->967; // weight: 0.9492 - 2105->1778; // weight: 0.03516 - 2105->1798; // weight: -0.005859 - 2105->2005; // weight: -0.005859 - 2105->2149; // weight: 0.0009766 - 2105->889; // weight: 0.1582 - 2105->963; // weight: -0.02637 - 2105->803; // weight: 0.1582 - 2105->957; // weight: -0.02637 - 2105->967; // weight: 0.7119 - 2117->1798; // weight: -0.2500 - 2117->2149; // weight: 0.1250 - 2117->963; // weight: 1.125 - 2120->1798; // weight: 0.1875 - 2120->2149; // weight: -0.03125 - 2120->963; // weight: 0.8438 - 2118->1778; // weight: 0.07813 - 2118->1798; // weight: -0.1172 - 2118->2005; // weight: -0.03906 - 2118->2149; // weight: 0.05859 - 2118->889; // weight: -0.3516 - 2118->963; // weight: 0.5273 - 2118->803; // weight: -0.2109 - 2118->957; // weight: 0.1055 - 2118->967; // weight: 0.9492 - 2121->1778; // weight: -0.05859 - 2121->1798; // weight: 0.08789 - 2121->2005; // weight: 0.009766 - 2121->2149; // weight: -0.01465 - 2121->889; // weight: -0.2637 - 2121->963; // weight: 0.3955 - 2121->803; // weight: 0.1582 - 2121->957; // weight: -0.02637 - 2121->967; // weight: 0.7119 - 2133->2005; // weight: -0.2500 - 2133->2149; // weight: 0.1250 - 2133->957; // weight: 1.125 - 2136->1778; // weight: 0.07813 - 2136->1798; // weight: -0.03906 - 2136->2005; // weight: -0.1172 - 2136->2149; // weight: 0.05859 - 2136->889; // weight: -0.2109 - 2136->963; // weight: 0.1055 - 2136->803; // weight: -0.3516 - 2136->957; // weight: 0.5273 - 2136->967; // weight: 0.9492 - 2134->2005; // weight: 0.1875 - 2134->2149; // weight: -0.03125 - 2134->957; // weight: 0.8438 - 2137->1778; // weight: -0.05859 - 2137->1798; // weight: 0.009766 - 2137->2005; // weight: 0.08789 - 2137->2149; // weight: -0.01465 - 2137->889; // weight: 0.1582 - 2137->963; // weight: -0.02637 - 2137->803; // weight: -0.2637 - 2137->957; // weight: 0.3955 - 2137->967; // weight: 0.7119 - 2152->1798; // weight: -0.3125 - 2152->2149; // weight: 0.4688 - 2152->963; // weight: 0.8438 - 2150->2005; // weight: -0.3125 - 2150->2149; // weight: 0.4688 - 2150->957; // weight: 0.8438 - 2153->1778; // weight: 0.09766 - 2153->1798; // weight: -0.1465 - 2153->2005; // weight: -0.1465 - 2153->2149; // weight: 0.2197 - 2153->889; // weight: -0.2637 - 2153->963; // weight: 0.3955 - 2153->803; // weight: -0.2637 - 2153->957; // weight: 0.3955 - 2153->967; // weight: 0.7119 -} -DEAL:: Number of degrees of freedom: 2721 -DEAL:: Number of constraints : 769 -DEAL:cg::Starting value 0.1181 -DEAL:cg::Convergence step 23 value 7.994e-10 diff --git a/tests/hp/crash_18_dynamic_sparsity.cc b/tests/hp/crash_18_dynamic_sparsity.cc deleted file mode 100644 index d3d84fe824..0000000000 --- a/tests/hp/crash_18_dynamic_sparsity.cc +++ /dev/null @@ -1,743 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2006 - 2015 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 at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// a modified version of step-27 that crashes because of circular -// constraints. like crash_17, but only check the second cycle. there, -// we have dofs that are constrained against itself, and we don't -// currently detect this... - -// like crash_18, but use a DynamicSparsityPattern instead to test -// that class some more - -char logname[] = "output"; - - -#include "../tests.h" - - -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include - -#include -#include - -#include -#include -#include -#include -#include - -#include - -// Finally, this is as in previous -// programs: -using namespace dealii; - -template -class LaplaceProblem -{ -public: - LaplaceProblem (); - ~LaplaceProblem (); - - void run (); - -private: - void setup_system (); - void assemble_system (); - void solve (); - void create_coarse_grid (); - void refine_grid (); - void estimate_smoothness (Vector &smoothness_indicators) const; - void output_results (const unsigned int cycle) const; - - Triangulation triangulation; - - hp::DoFHandler dof_handler; - hp::FECollection fe_collection; - hp::QCollection quadrature_collection; - hp::QCollection face_quadrature_collection; - - ConstraintMatrix hanging_node_constraints; - - SparsityPattern sparsity_pattern; - SparseMatrix system_matrix; - - Vector solution; - Vector system_rhs; - - Timer distr, condense, hang; -}; - - - -template -class RightHandSide : public Function -{ -public: - RightHandSide () : Function () {} - - virtual double value (const Point &p, - const unsigned int component) const; -}; - - -template -double -RightHandSide::value (const Point &p, - const unsigned int /*component*/) const -{ - double product = 1; - for (unsigned int d=0; d -LaplaceProblem::LaplaceProblem () : - dof_handler (triangulation) -{ - for (unsigned int degree=2; degree<5; ++degree) - { - fe_collection.push_back (FE_Q(QIterated<1>(QTrapez<1>(),degree))); - quadrature_collection.push_back (QGauss(degree+2)); - face_quadrature_collection.push_back (QGauss(degree+2)); - } -} - - -template -LaplaceProblem::~LaplaceProblem () -{ - dof_handler.clear (); -} - -template -void LaplaceProblem::setup_system () -{ - distr.reset(); - distr.start(); - dof_handler.distribute_dofs (fe_collection); - distr.stop(); - - solution.reinit (dof_handler.n_dofs()); - system_rhs.reinit (dof_handler.n_dofs()); - - hanging_node_constraints.clear (); - hang.reset(); - hang.start(); - DoFTools::make_hanging_node_constraints (dof_handler, - hanging_node_constraints); - - // check for self-referential constraints - - hanging_node_constraints.close (); - hang.stop(); - - if (dim < 3) - { - sparsity_pattern.reinit (dof_handler.n_dofs(), - dof_handler.n_dofs(), - dof_handler.max_couplings_between_dofs()); - DoFTools::make_sparsity_pattern (dof_handler, sparsity_pattern); - - condense.reset(); - condense.start(); - hanging_node_constraints.condense (sparsity_pattern); - condense.stop(); - sparsity_pattern.compress(); - } - else - { - DynamicSparsityPattern csp (dof_handler.n_dofs(), - dof_handler.n_dofs()); - DoFTools::make_sparsity_pattern (dof_handler, csp); - - condense.reset(); - condense.start(); - hanging_node_constraints.condense (csp); - condense.stop(); - - sparsity_pattern.copy_from (csp); - } - - system_matrix.reinit (sparsity_pattern); -} - -template -void LaplaceProblem::assemble_system () -{ - hp::FEValues hp_fe_values (fe_collection, - quadrature_collection, - update_values | update_gradients | - update_q_points | update_JxW_values); - - const RightHandSide rhs_function; - - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (; cell!=endc; ++cell) - { - const unsigned int dofs_per_cell = cell->get_fe().dofs_per_cell; - FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - Vector cell_rhs (dofs_per_cell); - - std::vector local_dof_indices (dofs_per_cell); - - cell_matrix = 0; - cell_rhs = 0; - - hp_fe_values.reinit (cell); - - const FEValues &fe_values = hp_fe_values.get_present_fe_values (); - - std::vector rhs_values (fe_values.n_quadrature_points); - rhs_function.value_list (fe_values.get_quadrature_points(), - rhs_values); - - for (unsigned int q_point=0; q_pointget_dof_indices (local_dof_indices); - for (unsigned int i=0; i boundary_values; - VectorTools::interpolate_boundary_values (dof_handler, - 0, - ZeroFunction(), - boundary_values); - MatrixTools::apply_boundary_values (boundary_values, - system_matrix, - solution, - system_rhs); -} - -template -void LaplaceProblem::solve () -{ - SolverControl solver_control (system_rhs.size(), - 1e-8*system_rhs.l2_norm()); - SolverCG<> cg (solver_control); - - PreconditionSSOR<> preconditioner; - preconditioner.initialize(system_matrix, 1.2); - - cg.solve (system_matrix, solution, system_rhs, - preconditioner); - - hanging_node_constraints.distribute (solution); -} - - -unsigned int -int_pow (const unsigned int x, - const unsigned int n) -{ - unsigned int p=1; - for (unsigned int i=0; i -void -LaplaceProblem:: -estimate_smoothness (Vector &smoothness_indicators) const -{ - const unsigned int N = 4; - - // form all the Fourier vectors - // that we want to - // consider. exclude k=0 to avoid - // problems with |k|^{-mu} and also - // logarithms of |k| - std::vector > k_vectors; - std::vector k_vectors_magnitude; - switch (dim) - { - case 2: - { - for (unsigned int i=0; i(numbers::PI * i, - numbers::PI * j)); - k_vectors_magnitude.push_back (i*i+j*j); - } - - break; - } - - case 3: - { - for (unsigned int i=0; i(numbers::PI * i, - numbers::PI * j, - numbers::PI * k)); - k_vectors_magnitude.push_back (i*i+j*j+k*k); - } - - break; - } - - default: - Assert (false, ExcNotImplemented()); - } - - const unsigned n_fourier_modes = k_vectors.size(); - std::vector ln_k (n_fourier_modes); - for (unsigned int i=0; i base_quadrature (2); - QIterated quadrature (base_quadrature, N); - - std::vector > > - fourier_transform_matrices (fe_collection.size()); - for (unsigned int fe=0; fe sum = 0; - for (unsigned int q=0; q x_q = quadrature.point(q); - sum += std::exp(std::complex(0,1) * - (k_vectors[k] * x_q)) * - fe_collection[fe].shape_value(i,x_q) * - quadrature.weight(q); - } - fourier_transform_matrices[fe](k,i) - = sum / std::pow(2*numbers::PI, 1.*dim/2); - } - } - - // the next thing is to loop over - // all cells and do our work there, - // i.e. to locally do the Fourier - // transform and estimate the decay - // coefficient - std::vector > fourier_coefficients (n_fourier_modes); - Vector local_dof_values; - - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (unsigned int index=0; cell!=endc; ++cell, ++index) - { - local_dof_values.reinit (cell->get_fe().dofs_per_cell); - cell->get_dof_values (solution, local_dof_values); - - // first compute the Fourier - // transform of the local - // solution - std::fill (fourier_coefficients.begin(), fourier_coefficients.end(), 0); - for (unsigned int f=0; fget_fe().dofs_per_cell; ++i) - fourier_coefficients[f] += - fourier_transform_matrices[cell->active_fe_index()](f,i) - * - local_dof_values(i); - - // enter the Fourier - // coefficients into a map with - // the k-magnitudes, to make - // sure that we get only the - // largest magnitude for each - // value of |k| - std::map k_to_max_U_map; - for (unsigned int f=0; f -void LaplaceProblem::refine_grid () -{ - Vector estimated_error_per_cell (triangulation.n_active_cells()); - KellyErrorEstimator::estimate (dof_handler, - face_quadrature_collection, - typename FunctionMap::type(), - solution, - estimated_error_per_cell); - - Vector smoothness_indicators (triangulation.n_active_cells()); - estimate_smoothness (smoothness_indicators); - - GridRefinement::refine_and_coarsen_fixed_number (triangulation, - estimated_error_per_cell, - 0.3, 0.03); - - float max_smoothness = 0, - min_smoothness = smoothness_indicators.linfty_norm(); - { - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (unsigned int index=0; cell!=endc; ++cell, ++index) - if (cell->refine_flag_set()) - { - max_smoothness = std::max (max_smoothness, - smoothness_indicators(index)); - min_smoothness = std::min (min_smoothness, - smoothness_indicators(index)); - } - } - const float cutoff_smoothness = (max_smoothness + min_smoothness) / 2; - { - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (unsigned int index=0; cell!=endc; ++cell, ++index) - if (cell->refine_flag_set() - && - (smoothness_indicators(index) > cutoff_smoothness) - && - !(cell->active_fe_index() == fe_collection.size() - 1)) - { - cell->clear_refine_flag(); - cell->set_active_fe_index (std::min (cell->active_fe_index() + 1, - fe_collection.size() - 1)); - } - } - - triangulation.execute_coarsening_and_refinement (); -} - - - -template -void LaplaceProblem::output_results (const unsigned int cycle) const -{ - Assert (cycle < 10, ExcNotImplemented()); - - { - const std::string filename = "grid-" + - Utilities::int_to_string (cycle, 2) + - ".eps"; - std::ofstream output (filename.c_str()); - - GridOut grid_out; - grid_out.write_eps (triangulation, output); - } - - { - Vector smoothness_indicators (triangulation.n_active_cells()); - estimate_smoothness (smoothness_indicators); - - Vector smoothness_field (dof_handler.n_dofs()); - DoFTools::distribute_cell_to_dof_vector (dof_handler, - smoothness_indicators, - smoothness_field); - - Vector fe_indices (triangulation.n_active_cells()); - { - typename hp::DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); - for (unsigned int index=0; cell!=endc; ++cell, ++index) - { - - fe_indices(index) = cell->active_fe_index(); -// smoothness_indicators(index) *= std::sqrt(cell->diameter()); - } - } - - const std::string filename = "solution-" + - Utilities::int_to_string (cycle, 2) + - ".vtk"; - DataOut > data_out; - - data_out.attach_dof_handler (dof_handler); - data_out.add_data_vector (solution, "solution"); - data_out.add_data_vector (smoothness_indicators, "smoothness1"); - data_out.add_data_vector (smoothness_field, "smoothness2"); - data_out.add_data_vector (fe_indices, "fe_index"); - data_out.build_patches (); - - std::ofstream output (filename.c_str()); - data_out.write_vtk (output); - } -} - - -template <> -void LaplaceProblem<2>::create_coarse_grid () -{ - const unsigned int dim = 2; - - static const Point<2> vertices_1[] - = { Point<2> (-1., -1.), - Point<2> (-1./2, -1.), - Point<2> (0., -1.), - Point<2> (+1./2, -1.), - Point<2> (+1, -1.), - - Point<2> (-1., -1./2.), - Point<2> (-1./2, -1./2.), - Point<2> (0., -1./2.), - Point<2> (+1./2, -1./2.), - Point<2> (+1, -1./2.), - - Point<2> (-1., 0.), - Point<2> (-1./2, 0.), - Point<2> (+1./2, 0.), - Point<2> (+1, 0.), - - Point<2> (-1., 1./2.), - Point<2> (-1./2, 1./2.), - Point<2> (0., 1./2.), - Point<2> (+1./2, 1./2.), - Point<2> (+1, 1./2.), - - Point<2> (-1., 1.), - Point<2> (-1./2, 1.), - Point<2> (0., 1.), - Point<2> (+1./2, 1.), - Point<2> (+1, 1.) - }; - const unsigned int - n_vertices = sizeof(vertices_1) / sizeof(vertices_1[0]); - const std::vector > vertices (&vertices_1[0], - &vertices_1[n_vertices]); - static const int cell_vertices[][GeometryInfo::vertices_per_cell] - = {{0, 1, 5, 6}, - {1, 2, 6, 7}, - {2, 3, 7, 8}, - {3, 4, 8, 9}, - {5, 6, 10, 11}, - {8, 9, 12, 13}, - {10, 11, 14, 15}, - {12, 13, 17, 18}, - {14, 15, 19, 20}, - {15, 16, 20, 21}, - {16, 17, 21, 22}, - {17, 18, 22, 23} - }; - const unsigned int - n_cells = sizeof(cell_vertices) / sizeof(cell_vertices[0]); - - std::vector > cells (n_cells, CellData()); - for (unsigned int i=0; i::vertices_per_cell; - ++j) - cells[i].vertices[j] = cell_vertices[i][j]; - cells[i].material_id = 0; - } - - triangulation.create_triangulation (vertices, - cells, - SubCellData()); - triangulation.refine_global (3); -} - - - -template <> -void LaplaceProblem<3>::create_coarse_grid () -{ - GridGenerator::hyper_cube (triangulation); - triangulation.refine_global (1); -} - - - -template -void LaplaceProblem::run () -{ - for (unsigned int cycle=0; cycle<2; ++cycle) - { - deallog << "Cycle " << cycle << ':' << std::endl; - - if (cycle == 0) - create_coarse_grid (); - else - refine_grid (); - - - deallog << " Number of active cells: " - << triangulation.n_active_cells() - << std::endl; - - Timer all; - all.start(); - setup_system (); - - deallog << " Number of degrees of freedom: " - << dof_handler.n_dofs() - << std::endl; - deallog << " Number of constraints : " - << hanging_node_constraints.n_constraints() - << std::endl; - - assemble_system (); - solve (); - all.stop(); - - } -} - -int main () -{ - std::ofstream logfile(logname); - logfile.precision (3); - deallog << std::setprecision(3); - - deallog.attach(logfile); - deallog.threshold_double(1.e-10); - try - { - LaplaceProblem<3> laplace_problem_2d; - laplace_problem_2d.run (); - } - catch (std::exception &exc) - { - std::cerr << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - std::cerr << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - - return 1; - } - catch (...) - { - std::cerr << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - std::cerr << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - } - - return 0; -} diff --git a/tests/hp/crash_18_dynamic_sparsity.output b/tests/hp/crash_18_dynamic_sparsity.output deleted file mode 100644 index 9ed4a96e46..0000000000 --- a/tests/hp/crash_18_dynamic_sparsity.output +++ /dev/null @@ -1,13 +0,0 @@ - -DEAL::Cycle 0: -DEAL:: Number of active cells: 8 -DEAL:: Number of degrees of freedom: 125 -DEAL:: Number of constraints : 0 -DEAL:cg::Starting value 0.438 -DEAL:cg::Convergence step 6 value 2.57e-09 -DEAL::Cycle 1: -DEAL:: Number of active cells: 22 -DEAL:: Number of degrees of freedom: 385 -DEAL:: Number of constraints : 128 -DEAL:cg::Starting value 0.337 -DEAL:cg::Convergence step 11 value 6.99e-10 diff --git a/tests/hp/step-11_dynamic_sparsity.cc b/tests/hp/step-11_dynamic_sparsity.cc deleted file mode 100644 index 222a40a7be..0000000000 --- a/tests/hp/step-11_dynamic_sparsity.cc +++ /dev/null @@ -1,257 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2005 - 2015 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 at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// a hp-ified version of step-11 - -// like step-11, but use a DynamicSparsityPattern instead to test -// that class some more - - -#include "../tests.h" - -#include -#include -std::ofstream logfile("output"); - -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include - -#include - -#include -#include -#include -#include - - -template -class LaplaceProblem -{ -public: - LaplaceProblem (const unsigned int mapping_degree); - void run (); - -private: - void setup_system (); - void assemble_and_solve (); - void solve (); - - Triangulation triangulation; - hp::FECollection fe; - hp::DoFHandler dof_handler; - hp::MappingCollection mapping; - - SparsityPattern sparsity_pattern; - SparseMatrix system_matrix; - ConstraintMatrix mean_value_constraints; - - Vector solution; - Vector system_rhs; - - TableHandler output_table; -}; - - - -template -LaplaceProblem::LaplaceProblem (const unsigned int mapping_degree) : - fe (FE_Q(1)), - dof_handler (triangulation), - mapping (MappingQ(mapping_degree)) -{ - deallog << "Using mapping with degree " << mapping_degree << ":" - << std::endl - << "============================" - << std::endl; -} - - - -template -void LaplaceProblem::setup_system () -{ - dof_handler.distribute_dofs (fe); - solution.reinit (dof_handler.n_dofs()); - system_rhs.reinit (dof_handler.n_dofs()); - - std::vector boundary_dofs (dof_handler.n_dofs(), false); - DoFTools::extract_boundary_dofs (dof_handler, std::vector(1,true), - boundary_dofs); - - const unsigned int first_boundary_dof - = std::distance (boundary_dofs.begin(), - std::find (boundary_dofs.begin(), - boundary_dofs.end(), - true)); - - mean_value_constraints.clear (); - mean_value_constraints.add_line (first_boundary_dof); - for (unsigned int i=first_boundary_dof+1; i -void LaplaceProblem::assemble_and_solve () -{ - - const unsigned int gauss_degree - = std::max (static_cast(std::ceil(1.*(static_cast&>(mapping[0]).get_degree()+1)/2)), - 2U); - MatrixTools::create_laplace_matrix (mapping, dof_handler, - hp::QCollection(QGauss(gauss_degree)), - system_matrix); - VectorTools::create_right_hand_side (mapping, dof_handler, - hp::QCollection(QGauss(gauss_degree)), - ConstantFunction(-2), - system_rhs); - Vector tmp (system_rhs.size()); - VectorTools::create_boundary_right_hand_side (mapping, dof_handler, - hp::QCollection(QGauss(gauss_degree)), - ConstantFunction(1), - tmp); - system_rhs += tmp; - - mean_value_constraints.condense (system_matrix); - mean_value_constraints.condense (system_rhs); - - solve (); - mean_value_constraints.distribute (solution); - - Vector norm_per_cell (triangulation.n_active_cells()); - VectorTools::integrate_difference (mapping, dof_handler, - solution, - ZeroFunction(), - norm_per_cell, - hp::QCollection(QGauss(gauss_degree+1)), - VectorTools::H1_seminorm); - const double norm = norm_per_cell.l2_norm(); - - output_table.add_value ("cells", triangulation.n_active_cells()); - output_table.add_value ("|u|_1", norm); - output_table.add_value ("error", std::fabs(norm-std::sqrt(3.14159265358/2))); -} - - - -template -void LaplaceProblem::solve () -{ - SolverControl solver_control (1000, 1e-12); - SolverCG<> cg (solver_control); - - PreconditionSSOR<> preconditioner; - preconditioner.initialize(system_matrix, 1.2); - - cg.solve (system_matrix, solution, system_rhs, - preconditioner); -} - - - -template -void LaplaceProblem::run () -{ - GridGenerator::hyper_ball (triangulation); - static const HyperBallBoundary boundary; - triangulation.set_boundary (0, boundary); - - for (unsigned int cycle=0; cycle<6; ++cycle, triangulation.refine_global(1)) - { - setup_system (); - assemble_and_solve (); - }; - - output_table.set_precision("|u|_1", 6); - output_table.set_precision("error", 6); - output_table.write_text (deallog.get_file_stream()); - deallog << std::endl; -} - - - -int main () -{ - try - { - logfile.precision(2); - deallog << std::setprecision(2); - - deallog.attach(logfile); - deallog.threshold_double(1.e-10); - - for (unsigned int mapping_degree=1; mapping_degree<=3; ++mapping_degree) - LaplaceProblem<2>(mapping_degree).run (); - } - catch (std::exception &exc) - { - std::cerr << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - std::cerr << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - } - catch (...) - { - std::cerr << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - std::cerr << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - }; - - return 0; -} diff --git a/tests/hp/step-11_dynamic_sparsity.output b/tests/hp/step-11_dynamic_sparsity.output deleted file mode 100644 index 7fcc7b83b6..0000000000 --- a/tests/hp/step-11_dynamic_sparsity.output +++ /dev/null @@ -1,67 +0,0 @@ - -DEAL::Using mapping with degree 1: -DEAL::============================ -DEAL:cg::Starting value 1.1 -DEAL:cg::Convergence step 7 value 0 -DEAL:cg::Starting value 1.0 -DEAL:cg::Convergence step 18 value 0 -DEAL:cg::Starting value 0.64 -DEAL:cg::Convergence step 29 value 0 -DEAL:cg::Starting value 0.35 -DEAL:cg::Convergence step 52 value 0 -DEAL:cg::Starting value 0.18 -DEAL:cg::Convergence step 106 value 0 -DEAL:cg::Starting value 0.094 -DEAL:cg::Convergence step 234 value 0 -cells |u|_1 error -5 0.680402 0.572912 -20 1.088141 0.165173 -80 1.210142 0.043172 -320 1.242375 0.010939 -1280 1.250569 0.002745 -5120 1.252627 0.000687 -DEAL:: -DEAL::Using mapping with degree 2: -DEAL::============================ -DEAL:cg::Starting value 1.3 -DEAL:cg::Convergence step 7 value 0 -DEAL:cg::Starting value 1.1 -DEAL:cg::Convergence step 17 value 0 -DEAL:cg::Starting value 0.65 -DEAL:cg::Convergence step 28 value 0 -DEAL:cg::Starting value 0.35 -DEAL:cg::Convergence step 51 value 0 -DEAL:cg::Starting value 0.18 -DEAL:cg::Convergence step 106 value 0 -DEAL:cg::Starting value 0.094 -DEAL:cg::Convergence step 233 value 0 -cells |u|_1 error -5 1.050963 0.202351 -20 1.203014 0.050300 -80 1.241120 0.012194 -320 1.250319 0.002996 -1280 1.252572 0.000742 -5120 1.253129 0.000185 -DEAL:: -DEAL::Using mapping with degree 3: -DEAL::============================ -DEAL:cg::Starting value 1.4 -DEAL:cg::Convergence step 7 value 0 -DEAL:cg::Starting value 1.1 -DEAL:cg::Convergence step 17 value 0 -DEAL:cg::Starting value 0.65 -DEAL:cg::Convergence step 28 value 0 -DEAL:cg::Starting value 0.35 -DEAL:cg::Convergence step 51 value 0 -DEAL:cg::Starting value 0.18 -DEAL:cg::Convergence step 106 value 0 -DEAL:cg::Starting value 0.094 -DEAL:cg::Convergence step 233 value 0 -cells |u|_1 error -5 1.084317 0.168997 -20 1.207179 0.046135 -80 1.241643 0.011671 -320 1.250384 0.002930 -1280 1.252580 0.000734 -5120 1.253130 0.000184 -DEAL:: diff --git a/tests/lac/chunk_sparsity_pattern_08.cc b/tests/lac/chunk_sparsity_pattern_08.cc deleted file mode 100644 index 3d4c20281f..0000000000 --- a/tests/lac/chunk_sparsity_pattern_08.cc +++ /dev/null @@ -1,39 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2008 - 2015 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 at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check ChunkSparsityPattern::copy_from - -#include "sparsity_pattern_common.h" - -int main () -{ - std::ofstream logfile("output"); - logfile.setf(std::ios::fixed); - deallog << std::setprecision(3); - deallog.attach(logfile); - deallog.threshold_double(1.e-10); - - const unsigned int chunk_sizes[] = { 1, 2, 4, 5, 7 }; - for (unsigned int i=0; i (); - } -} - - - diff --git a/tests/lac/chunk_sparsity_pattern_08.output b/tests/lac/chunk_sparsity_pattern_08.output deleted file mode 100644 index 9771f830c2..0000000000 --- a/tests/lac/chunk_sparsity_pattern_08.output +++ /dev/null @@ -1,11 +0,0 @@ - -DEAL::196 196 14 924 -DEAL::OK -DEAL::196 196 14 924 -DEAL::OK -DEAL::196 196 14 924 -DEAL::OK -DEAL::196 196 14 924 -DEAL::OK -DEAL::196 196 14 924 -DEAL::OK diff --git a/tests/lac/sparsity_pattern_12.cc b/tests/lac/sparsity_pattern_12.cc deleted file mode 100644 index 94015d7ae4..0000000000 --- a/tests/lac/sparsity_pattern_12.cc +++ /dev/null @@ -1,34 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2008 - 2015 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 at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check SparsityPattern::copy_from - -#include "sparsity_pattern_common.h" - -int main () -{ - std::ofstream logfile("output"); - logfile.setf(std::ios::fixed); - deallog << std::setprecision(3); - deallog.attach(logfile); - deallog.threshold_double(1.e-10); - - copy_from_2 (); -} - - - diff --git a/tests/lac/sparsity_pattern_12.output b/tests/lac/sparsity_pattern_12.output deleted file mode 100644 index abdb63db07..0000000000 --- a/tests/lac/sparsity_pattern_12.output +++ /dev/null @@ -1,3 +0,0 @@ - -DEAL::196 196 14 924 -DEAL::OK