diff --git a/benchmarks/solitary_wave/solitary_wave.cc b/benchmarks/solitary_wave/solitary_wave.cc index 202350a76dc..cbfba28ca6c 100644 --- a/benchmarks/solitary_wave/solitary_wave.cc +++ b/benchmarks/solitary_wave/solitary_wave.cc @@ -22,6 +22,7 @@ #include #include #include +#include #include #include @@ -828,13 +829,13 @@ namespace aspect AssertThrow(this->introspection().compositional_name_exists("porosity"), ExcMessage("Postprocessor Solitary Wave only works if there is a compositional field called porosity.")); const unsigned int porosity_index = this->introspection().compositional_index_for_name("porosity"); + const typename Simulator::AdvectionField porosity = Simulator::AdvectionField::composition(porosity_index); // create a quadrature formula based on the compositional element alone. - // be defensive about determining that a compositional field actually exists - AssertThrow (this->introspection().base_elements.compositional_fields - != numbers::invalid_unsigned_int, + AssertThrow (this->introspection().n_compositional_fields > 0, ExcMessage("This postprocessor cannot be used without compositional fields.")); - const QGauss quadrature_formula (this->get_fe().base_element(this->introspection().base_elements.compositional_fields).degree+1); + + const QGauss quadrature_formula (this->get_fe().base_element(porosity.base_element(this->introspection())).degree+1); const unsigned int n_q_points = quadrature_formula.size(); FEValues fe_values (this->get_mapping(), diff --git a/cookbooks/kinematically_driven_subduction_2d/trench_location.cc b/cookbooks/kinematically_driven_subduction_2d/trench_location.cc index 45eece46481..c0d283ca959 100644 --- a/cookbooks/kinematically_driven_subduction_2d/trench_location.cc +++ b/cookbooks/kinematically_driven_subduction_2d/trench_location.cc @@ -35,8 +35,7 @@ namespace aspect TrenchLocation::execute (TableHandler &statistics) { // create a quadrature formula based on the compositional element alone. - // be defensive about determining that a compositional field actually exists - AssertThrow(this->introspection().base_elements.compositional_fields != numbers::invalid_unsigned_int, + AssertThrow(this->introspection().n_compositional_fields > 0, ExcMessage("This postprocessor cannot be used without compositional fields.")); const Quadrature &quadrature_formula = this->introspection().face_quadratures.compositional_fields; diff --git a/include/aspect/introspection.h b/include/aspect/introspection.h index 163e1d01538..9f438e750fc 100644 --- a/include/aspect/introspection.h +++ b/include/aspect/introspection.h @@ -31,6 +31,7 @@ #include #include +#include namespace aspect { @@ -246,18 +247,17 @@ namespace aspect * A structure that enumerates the base elements of the finite element * that correspond to each of the variables in this problem. * - * If there are compositional fields, they are all discretized with the - * same base element and, consequently, we only need a single index. If - * a variable does not exist in the problem (e.g., we do not have - * compositional fields), then the corresponding index is set to an - * invalid number. + * The indices here can be used to access the dealii::FiniteElement + * that describes the given variable. We support different finite + * elements for compositional fields, but we try to reuse the same + * element if possible. */ struct BaseElements { - unsigned int velocities; - unsigned int pressure; - unsigned int temperature; - unsigned int compositional_fields; + unsigned int velocities; + unsigned int pressure; + unsigned int temperature; + std::vector compositional_fields; }; /** @@ -441,6 +441,7 @@ namespace aspect */ IndexSet locally_owned_fluid_pressure_dofs; }; + /** * A variable that contains index sets describing which of the globally * enumerated degrees of freedom are owned by the current processor in a @@ -465,6 +466,31 @@ namespace aspect * @} */ + /** + * Return a vector that contains the base element indices of the deal.II FiniteElement + * that are used for compositional fields. Note that compositional fields can share the + * same base element, so this vector can (and usually will) be smaller than the number + * of compositional fields. The function get_compositional_field_indices_with_base_element() + * can be used to translate from base element index to all compositional field indices + * using the specified base element. + * If several fields are the finite element type (same degree and both continuous or both + * discontinuous), they share base elements. If you have no compositional fields, the + * vector returned has length 0. If all compositional fields have the same finite element + * space, the length is 1. + */ + std::vector + get_composition_base_element_indices() const; + + /** + * Return a vector with all compositional field indices that belong to a given + * base element index as returned by get_composition_base_element_indices(). + * The indices returned are therefore between 0 and n_compositional_fields-1. + * If you have a single compositional field, this function returns {0} when passing + * in base_element_index=0. + */ + std::vector + get_compositional_field_indices_with_base_element(const unsigned int base_element_index) const; + /** * A function that gets the name of a compositional field as an input * parameter and returns its index. If the name is not found, an @@ -593,6 +619,16 @@ namespace aspect bool is_stokes_component (const unsigned int component_index) const; + /** + * A function that gets a component index as an input + * parameter and returns if the component is one of the + * compositional fields. + * + * @param component_index The component index to check. + */ + bool + is_composition_component (const unsigned int component_index) const; + private: /** * A vector that stores the names of the compositional fields that will @@ -620,6 +656,19 @@ namespace aspect * given in CompositionalFieldDescription. */ std::vector> composition_indices_for_type; + + /** + * List of base element indices used by compositional fields. Cached + * result returned by get_composition_base_element_indices(). + */ + std::vector composition_base_element_indices; + + /** + * Map base_element_index to list of compositional field indices that use + * that base element. Cached result returned by + * get_compositional_field_indices_with_base_element(); + */ + std::map> compositional_field_indices_with_base_element; }; } diff --git a/source/mesh_refinement/composition_gradient.cc b/source/mesh_refinement/composition_gradient.cc index ec313514af0..47eace30bb8 100644 --- a/source/mesh_refinement/composition_gradient.cc +++ b/source/mesh_refinement/composition_gradient.cc @@ -19,6 +19,7 @@ */ +#include #include #include @@ -37,44 +38,50 @@ namespace aspect "compositional fields are active!")); indicators = 0; - Vector this_indicator (indicators.size()); const double power = 1.0 + dim/2.0; - const Quadrature quadrature(this->get_fe().base_element(this->introspection().base_elements.compositional_fields).get_unit_support_points()); - FEValues fe_values (this->get_mapping(), - this->get_fe(), - quadrature, - update_quadrature_points | update_gradients); + for (const unsigned int base_element_index : this->introspection().get_composition_base_element_indices()) + { + const Quadrature quadrature (this->get_fe().base_element(base_element_index).get_unit_support_points()); + const unsigned int dofs_per_cell = quadrature.size(); + FEValues fe_values (this->get_mapping(), + this->get_fe(), + quadrature, + update_quadrature_points | update_gradients); - // the values of the compositional fields are stored as block vectors for each field - // we have to extract them in this structure - std::vector> composition_gradients (quadrature.size()); + // the values of the compositional fields are stored as block vectors for each field + // we have to extract them in this structure + std::vector> composition_gradients (quadrature.size()); - for (unsigned int c=0; cn_compositional_fields(); ++c) - { for (const auto &cell : this->get_dof_handler().active_cell_iterators()) if (cell->is_locally_owned()) { const unsigned int idx = cell->active_cell_index(); fe_values.reinit(cell); - fe_values[this->introspection().extractors.compositional_fields[c]].get_function_gradients (this->get_solution(), - composition_gradients); - - // For each composition dof, write into the output vector the - // composition gradient. Note that quadrature points and dofs - // are enumerated in the same order. - for (unsigned int j=0; jget_fe().base_element(this->introspection().base_elements.compositional_fields).dofs_per_cell; ++j) - this_indicator[idx] += composition_gradients[j].norm(); - - // Scale gradient in each cell with the correct power of h. Otherwise, - // error indicators do not reduce when refined if there is a density - // jump. We need at least order 1 for the error not to grow when - // refining, so anything >1 should work. (note that the gradient - // itself scales like 1/h, so multiplying it with any factor h^s, s>1 - // will yield convergence of the error indicators to zero as h->0) - this_indicator[idx] *= std::pow(cell->diameter(), power); + + for (const unsigned int c : this->introspection().get_compositional_field_indices_with_base_element(base_element_index)) + { + const typename Simulator::AdvectionField composition = Simulator::AdvectionField::composition(c); + fe_values[composition.scalar_extractor(this->introspection())].get_function_gradients (this->get_solution(), + composition_gradients); + + // Some up the indicators for this composition on this cell. Note that quadrature points and dofs + // are enumerated in the same order. + double this_indicator = 0.0; + for (unsigned int j=0; j1 should work. (note that the gradient + // itself scales like 1/h, so multiplying it with any factor h^s, s>1 + // will yield convergence of the error indicators to zero as h->0) + this_indicator *= std::pow(cell->diameter(), power); + + indicators[idx] += composition_scaling_factors[c] * this_indicator; + } } - indicators.add(composition_scaling_factors[c], this_indicator); } } diff --git a/source/postprocess/composition_statistics.cc b/source/postprocess/composition_statistics.cc index 748d22e1c17..d0073fcf11c 100644 --- a/source/postprocess/composition_statistics.cc +++ b/source/postprocess/composition_statistics.cc @@ -37,10 +37,6 @@ namespace aspect return {"", ""}; // create a quadrature formula based on the compositional element alone. - // be defensive about determining that a compositional field actually exists - AssertThrow (this->introspection().base_elements.compositional_fields - != numbers::invalid_unsigned_int, - ExcMessage("This postprocessor cannot be used without compositional fields.")); const Quadrature &quadrature_formula = this->introspection().quadratures.compositional_fields; const unsigned int n_q_points = quadrature_formula.size(); diff --git a/source/postprocess/max_depth_field.cc b/source/postprocess/max_depth_field.cc index fdd9f43d6bf..d0cba1d2a56 100644 --- a/source/postprocess/max_depth_field.cc +++ b/source/postprocess/max_depth_field.cc @@ -36,7 +36,7 @@ namespace aspect { // create a quadrature formula based on the compositional element alone. // be defensive about determining that a compositional field actually exists - AssertThrow(this->introspection().base_elements.compositional_fields != numbers::invalid_unsigned_int, + AssertThrow(this->n_compositional_fields() > 0, ExcMessage("This postprocessor cannot be used without compositional fields.")); const Quadrature &quadrature_formula = this->introspection().quadratures.compositional_fields; diff --git a/source/simulator/helper_functions.cc b/source/simulator/helper_functions.cc index f100bede553..e0658a71e2a 100644 --- a/source/simulator/helper_functions.cc +++ b/source/simulator/helper_functions.cc @@ -174,7 +174,7 @@ namespace aspect if (this->is_temperature()) return introspection.base_elements.temperature; else - return introspection.base_elements.compositional_fields; + return introspection.base_elements.compositional_fields[compositional_variable]; } template @@ -184,7 +184,11 @@ namespace aspect if (this->is_temperature()) return introspection.extractors.temperature; else - return introspection.extractors.compositional_fields[compositional_variable]; + { + Assert(compositional_variable < introspection.n_compositional_fields, + ExcMessage("Invalid AdvectionField.")); + return introspection.extractors.compositional_fields[compositional_variable]; + } } template @@ -1686,55 +1690,80 @@ namespace aspect pcout << " Solving composition reactions... " << std::flush; - // make one fevalues for the composition, and one for the temperature (they might use different finite elements) - const Quadrature quadrature_C(dof_handler.get_fe().base_element(introspection.base_elements.compositional_fields).get_unit_support_points()); - FEValues fe_values_C (*mapping, - dof_handler.get_fe(), - quadrature_C, - update_quadrature_points | update_values | update_gradients); - - std::vector local_dof_indices (dof_handler.get_fe().dofs_per_cell); - MaterialModel::MaterialModelInputs in_C(quadrature_C.size(), introspection.n_compositional_fields); - MaterialModel::MaterialModelOutputs out_C(quadrature_C.size(), introspection.n_compositional_fields); - HeatingModel::HeatingModelOutputs heating_model_outputs_C(quadrature_C.size(), introspection.n_compositional_fields); + // We want to compute reactions in each support point for all fields (compositional fields and temperature). The reaction + // rate for an individual field depends on the values of all other fields, so we have to step them forward in time together. + // The rates comes from the material and heating model, otherwise we have a simple ODE in each point on each cell to solve. + // + // So far so good. Except that fields can have different Finite Element discretizations (degree, continuous/discontinuous) + // and will have different support points. We solve this by computing the union of all support points and evaluating all fields + // in these points for every cell (if necessary by interpolation). Then we solve the ODEs on each cell together and + // write back all values that correspond to support points of that particular field. Field values we computed that are + // not actually support points, we just throw away. + + // First compute the union of all support points (temperature and compositions): + std::vector> unique_support_points; + // For each field (T or composition) store where each support point is found in the list of indices of support points + // unique_support_points. This means index=support_point_index_by_field[0][3] is the index of the third support point + // of the temperature field and unique_support_points[index] is its location. + std::vector> support_point_index_by_field(1+introspection.n_compositional_fields); + + // Fill in the support_point_index_by_field data structure. This is a bit complicated... + { + // first fill in temperature: + unique_support_points = dof_handler.get_fe().base_element(introspection.base_elements.temperature).get_unit_support_points(); + for (unsigned int i=0; i::AdvectionField::composition(c); + const std::vector> &points = dof_handler.get_fe().base_element(composition.base_element(introspection)).get_unit_support_points(); - // temperature element - const Quadrature quadrature_T(dof_handler.get_fe().base_element(introspection.base_elements.temperature).get_unit_support_points()); + for (unsigned int i=0; i fe_values_T (*mapping, - dof_handler.get_fe(), - quadrature_T, - update_quadrature_points | update_values | update_gradients); + const Quadrature combined_support_points(unique_support_points); + FEValues fe_values (*mapping, + dof_handler.get_fe(), + combined_support_points, + update_quadrature_points | update_values | update_gradients); - MaterialModel::MaterialModelInputs in_T(quadrature_T.size(), introspection.n_compositional_fields); - MaterialModel::MaterialModelOutputs out_T(quadrature_T.size(), introspection.n_compositional_fields); - HeatingModel::HeatingModelOutputs heating_model_outputs_T(quadrature_T.size(), introspection.n_compositional_fields); + std::vector local_dof_indices (dof_handler.get_fe().dofs_per_cell); + MaterialModel::MaterialModelInputs in(combined_support_points.size(), introspection.n_compositional_fields); + MaterialModel::MaterialModelOutputs out(combined_support_points.size(), introspection.n_compositional_fields); + HeatingModel::HeatingModelOutputs heating_model_outputs(combined_support_points.size(), introspection.n_compositional_fields); // add reaction rate outputs - material_model->create_additional_named_outputs(out_C); - material_model->create_additional_named_outputs(out_T); - - MaterialModel::ReactionRateOutputs *reaction_rate_outputs_C - = out_C.template get_additional_output>(); + material_model->create_additional_named_outputs(out); - MaterialModel::ReactionRateOutputs *reaction_rate_outputs_T - = out_T.template get_additional_output>(); + MaterialModel::ReactionRateOutputs *reaction_rate_outputs + = out.template get_additional_output>(); - AssertThrow(reaction_rate_outputs_C != nullptr && reaction_rate_outputs_T != nullptr, + AssertThrow(reaction_rate_outputs != nullptr, ExcMessage("You are trying to use the operator splitting solver scheme, " "but the material model you use does not support operator splitting " "(it does not create ReactionRateOutputs, which are required for this " "solver scheme).")); // some heating models require the additional outputs - heating_model_manager.create_additional_material_model_inputs_and_outputs(in_C, out_C); - heating_model_manager.create_additional_material_model_inputs_and_outputs(in_T, out_T); + heating_model_manager.create_additional_material_model_inputs_and_outputs(in, out); // Make a loop first over all cells, than over all reaction time steps, and then over // all degrees of freedom in each element to compute the reactions. This is possible @@ -1746,114 +1775,88 @@ namespace aspect // interface between cells), as we loop over all cells, and then over all degrees of freedom // on each cell. Although this means we do some additional work, the results are still // correct, as we never read from distributed_vector inside the loop over all cells. - // We initialize the material model inputs objects in_T and in_C using the solution vector + // We initialize the material model inputs object in using the solution vector // on every cell, compute the update, and then on every cell put the result into the // distributed_vector vector. Only after the loop over all cells do we copy distributed_vector // back onto the solution vector. // So even though we touch some DoF more than once, we always start from the same value, compute the // same value, and then overwrite the same value in distributed_vector. - // TODO: make this more efficient. + // TODO: make this even more efficient. for (const auto &cell : dof_handler.active_cell_iterators()) if (cell->is_locally_owned()) { - fe_values_C.reinit (cell); - in_C.reinit(fe_values_C, cell, introspection, solution); - - if (temperature_and_composition_use_same_fe == false) - { - fe_values_T.reinit (cell); - in_T.reinit(fe_values_T, cell, introspection, solution); - } + fe_values.reinit (cell); + in.reinit(fe_values, cell, introspection, solution); - std::vector> accumulated_reactions_C (quadrature_C.size(),std::vector (introspection.n_compositional_fields)); - std::vector accumulated_reactions_T (quadrature_T.size()); + std::vector> accumulated_reactions_C (combined_support_points.size(), std::vector (introspection.n_compositional_fields)); + std::vector accumulated_reactions_T (combined_support_points.size()); // Make the reaction time steps: We have to update the values of compositional fields and the temperature. - // Because temperature and composition might use different finite elements, we loop through their elements - // separately, and update the temperature and the compositions for both. // We can reuse the same material model inputs and outputs structure for each reaction time step. // We store the computed updates to temperature and composition in a separate (accumulated_reactions) vector, // so that we can later copy it over to the solution vector. for (unsigned int i=0; ifill_additional_material_model_inputs(in_C, solution, fe_values_C, introspection); + material_model->fill_additional_material_model_inputs(in, solution, fe_values, introspection); - material_model->evaluate(in_C, out_C); - heating_model_manager.evaluate(in_C, out_C, heating_model_outputs_C); + material_model->evaluate(in, out); + heating_model_manager.evaluate(in, out, heating_model_outputs); - for (unsigned int j=0; jreaction_rates[j][c]; - accumulated_reactions_C[j][c] += reaction_time_step_size * reaction_rate_outputs_C->reaction_rates[j][c]; + in.composition[j][c] = in.composition[j][c] + + reaction_time_step_size * reaction_rate_outputs->reaction_rates[j][c]; + accumulated_reactions_C[j][c] += reaction_time_step_size * reaction_rate_outputs->reaction_rates[j][c]; } - in_C.temperature[j] = in_C.temperature[j] - + reaction_time_step_size * heating_model_outputs_C.rates_of_temperature_change[j]; + in.temperature[j] = in.temperature[j] + + reaction_time_step_size * heating_model_outputs.rates_of_temperature_change[j]; - if (temperature_and_composition_use_same_fe) - accumulated_reactions_T[j] += reaction_time_step_size * heating_model_outputs_C.rates_of_temperature_change[j]; - } - - if (!temperature_and_composition_use_same_fe) - { - // loop over temperature element - material_model->fill_additional_material_model_inputs(in_T, solution, fe_values_T, introspection); - - material_model->evaluate(in_T, out_T); - heating_model_manager.evaluate(in_T, out_T, heating_model_outputs_T); - - for (unsigned int j=0; jreaction_rates[j][c]; - } + accumulated_reactions_T[j] += reaction_time_step_size * heating_model_outputs.rates_of_temperature_change[j]; } } cell->get_dof_indices (local_dof_indices); + const unsigned int component_idx_T = introspection.component_indices.temperature; - // copy reaction rates and new values for the compositional fields - for (unsigned int j=0; j=component_idx_T) // ignore velocity, pressure, etc. { - if (temperature_and_composition_use_same_fe) - distributed_vector(local_dof_indices[temperature_idx]) = in_C.temperature[j]; - else - distributed_vector(local_dof_indices[temperature_idx]) = in_T.temperature[j]; - - distributed_reaction_vector(local_dof_indices[temperature_idx]) = accumulated_reactions_T[j]; + // We found a DoF that belongs to component component_idx, which is a temperature or compositional + // field. That means we want to find where this DoF in the computed reactions above to copy it + // back into the global solution vector. + + // These two variables tell us the how-manyth shape function of which field (and therefore + // field) this DoF is: + const unsigned int index_within = comp_pair.second; + const unsigned int field_index = component_idx-component_idx_T; + // Now we can look up in the support_point_index_by_field data structure where this support + // point is in the list of unique_support_points (and in the Quadrature): + const unsigned int point_idx = support_point_index_by_field[field_index][index_within]; + + // The final step is grabbing the value from the reaction computation and write it into + // the global vector (if we own it, of course): + if (dof_handler.locally_owned_dofs().is_element(local_dof_indices[dof_idx])) + { + // temperatures and compositions are stored differently: + if (component_idx == component_idx_T) + { + distributed_vector(local_dof_indices[dof_idx]) = in.temperature[point_idx]; + distributed_reaction_vector(local_dof_indices[dof_idx]) = accumulated_reactions_T[point_idx]; + } + else + { + const unsigned int composition = field_index-1; // 0 is temperature... + distributed_vector(local_dof_indices[dof_idx]) = in.composition[point_idx][composition]; + distributed_reaction_vector(local_dof_indices[dof_idx]) = accumulated_reactions_C[point_idx][composition]; + } + } } } } diff --git a/source/simulator/introspection.cc b/source/simulator/introspection.cc index c1378342368..7badb51df17 100644 --- a/source/simulator/introspection.cc +++ b/source/simulator/introspection.cc @@ -21,7 +21,7 @@ #include #include - +#include #include #include @@ -56,14 +56,13 @@ namespace aspect */ template typename Introspection::BlockIndices - setup_blocks (FEVariableCollection &fevs) + setup_blocks (FEVariableCollection &fevs, const unsigned int n_compositional_fields) { typename Introspection::BlockIndices b; b.velocities = fevs.variable("velocity").block_index; b.pressure = fevs.variable("pressure").block_index; b.temperature = fevs.variable("temperature").block_index; - unsigned int n_compositional_fields = fevs.variable("compositions").n_components(); const unsigned int first_composition_block_index = fevs.variable("compositions").block_index; for (unsigned int i=0; i typename Introspection::BaseElements - setup_base_elements (FEVariableCollection &fevs) + setup_base_elements (FEVariableCollection &fevs, const unsigned int n_compositional_fields) { typename Introspection::BaseElements base_elements; base_elements.velocities = fevs.variable("velocity").base_index; base_elements.pressure = fevs.variable("pressure").base_index; base_elements.temperature = fevs.variable("temperature").base_index; - base_elements.compositional_fields = fevs.variable("compositions").base_index; + base_elements.compositional_fields = Utilities::possibly_extend_from_1_to_N(std::vector({fevs.variable("compositions").base_index}), + n_compositional_fields, ""); return base_elements; } @@ -247,9 +247,9 @@ namespace aspect use_discontinuous_composition_discretization (parameters.use_discontinuous_composition_discretization), component_indices (internal::setup_component_indices(*this)), n_blocks(FEVariableCollection::n_blocks()), - block_indices (internal::setup_blocks(*this)), + block_indices (internal::setup_blocks(*this, parameters.n_compositional_fields)), extractors (component_indices), - base_elements (internal::setup_base_elements(*this)), + base_elements (internal::setup_base_elements(*this, parameters.n_compositional_fields)), polynomial_degree (internal::setup_polynomial_degree(parameters)), quadratures (internal::setup_quadratures(parameters, ReferenceCells::get_hypercube())), face_quadratures (internal::setup_face_quadratures(parameters, ReferenceCells::get_hypercube())), @@ -268,6 +268,42 @@ namespace aspect composition_indices_for_type[composition_descriptions[c].type].push_back(c); composition_names_for_type[composition_descriptions[c].type].push_back(composition_names[c]); } + + // Fill composition_base_element_indices + { + if (this->n_compositional_fields > 0) + { + // We are assigning base elements in order, so the first compositional field + // gives us the first base element index. Then we find the largest index + // in the vector. This is necessary, because the fields could have type A,B,A. + const unsigned int first = this->base_elements.compositional_fields[0]; + const unsigned int last = *std::max_element(this->base_elements.compositional_fields.begin(), + this->base_elements.compositional_fields.end()); + + composition_base_element_indices.resize(last-first+1); + std::iota(composition_base_element_indices.begin(), composition_base_element_indices.end(), first); + } + } + +// Fill compositional_field_indices_with_base_element + { + for (const auto base_element_index : composition_base_element_indices) + { + std::vector result; + + unsigned int idx = 0; + for (const auto base_idx : this->base_elements.compositional_fields) + { + if (base_idx == base_element_index) + result.emplace_back(idx); + ++idx; + } + + Assert(result.size() > 0, ExcInternalError("There should be at least one compositional field for a valid base element.")); + compositional_field_indices_with_base_element[base_element_index] = result; + } + } + } @@ -333,6 +369,27 @@ namespace aspect + template + std::vector + Introspection::get_composition_base_element_indices() const + { + return composition_base_element_indices; + } + + + + template + std::vector + Introspection::get_compositional_field_indices_with_base_element(const unsigned int base_element_index) const + { + Assert(compositional_field_indices_with_base_element.find(base_element_index) + != compositional_field_indices_with_base_element.end(), + ExcMessage("Invalid base_element_index specified.")); + return compositional_field_indices_with_base_element.find(base_element_index)->second; + } + + + template unsigned int Introspection::compositional_index_for_name (const std::string &name) const @@ -353,7 +410,7 @@ namespace aspect Introspection::name_for_compositional_index (const unsigned int index) const { // make sure that what we get here is really an index of one of the compositional fields - AssertIndexRange(index,composition_names.size()); + AssertIndexRange(index, composition_names.size()); return composition_names[index]; } @@ -488,6 +545,22 @@ namespace aspect } + + template + bool + Introspection::is_composition_component (const unsigned int component_index) const + { + // All compositions live at the end. Just to be sure, there are no other components + // in our system after compositional fields, right? + Assert(component_indices.compositional_fields[0] > component_indices.temperature + && component_indices.compositional_fields.back() == n_components-1, ExcInternalError()); + + if (component_index >= component_indices.compositional_fields[0]) + return true; + else + return false; + } + } diff --git a/tests/discontinuous_composition_serial_periodic_amr/screen-output b/tests/discontinuous_composition_serial_periodic_amr/screen-output index e0717f74a5a..318ec414028 100644 --- a/tests/discontinuous_composition_serial_periodic_amr/screen-output +++ b/tests/discontinuous_composition_serial_periodic_amr/screen-output @@ -225,8 +225,7 @@ Skipping mesh refinement, because the mesh did not change. Postprocessing: Writing graphical output: output-discontinuous_composition_serial_periodic_amr/solution/solution-00022 -Number of active cells: 184 (on 5 levels) -Number of degrees of freedom: 4,359 (1,654+222+827+1,656) +Skipping mesh refinement, because the mesh did not change. *** Timestep 23: t=1.4375 seconds, dt=0.0625 seconds Skipping temperature solve because RHS is zero. @@ -235,7 +234,8 @@ Number of degrees of freedom: 4,359 (1,654+222+827+1,656) Postprocessing: Writing graphical output: output-discontinuous_composition_serial_periodic_amr/solution/solution-00023 -Skipping mesh refinement, because the mesh did not change. +Number of active cells: 184 (on 5 levels) +Number of degrees of freedom: 4,359 (1,654+222+827+1,656) *** Timestep 24: t=1.5 seconds, dt=0.0625 seconds Skipping temperature solve because RHS is zero. @@ -303,8 +303,8 @@ Number of degrees of freedom: 3,605 (1,390+188+695+1,332) Postprocessing: Writing graphical output: output-discontinuous_composition_serial_periodic_amr/solution/solution-00030 -Number of active cells: 160 (on 5 levels) -Number of degrees of freedom: 3,824 (1,458+197+729+1,440) +Number of active cells: 184 (on 5 levels) +Number of degrees of freedom: 4,359 (1,654+222+827+1,656) *** Timestep 31: t=1.9375 seconds, dt=0.0625 seconds Skipping temperature solve because RHS is zero. @@ -313,8 +313,7 @@ Number of degrees of freedom: 3,824 (1,458+197+729+1,440) Postprocessing: Writing graphical output: output-discontinuous_composition_serial_periodic_amr/solution/solution-00031 -Number of active cells: 184 (on 5 levels) -Number of degrees of freedom: 4,359 (1,654+222+827+1,656) +Skipping mesh refinement, because the mesh did not change. *** Timestep 32: t=2 seconds, dt=0.0625 seconds Skipping temperature solve because RHS is zero. @@ -491,8 +490,7 @@ Skipping mesh refinement, because the mesh did not change. Postprocessing: Writing graphical output: output-discontinuous_composition_serial_periodic_amr/solution/solution-00050 -Number of active cells: 160 (on 5 levels) -Number of degrees of freedom: 3,744 (1,410+189+705+1,440) +Skipping mesh refinement, because the mesh did not change. *** Timestep 51: t=3.1875 seconds, dt=0.0625 seconds Skipping temperature solve because RHS is zero. @@ -501,8 +499,8 @@ Number of degrees of freedom: 3,744 (1,410+189+705+1,440) Postprocessing: Writing graphical output: output-discontinuous_composition_serial_periodic_amr/solution/solution-00051 -Number of active cells: 184 (on 5 levels) -Number of degrees of freedom: 4,359 (1,654+222+827+1,656) +Number of active cells: 160 (on 5 levels) +Number of degrees of freedom: 3,744 (1,410+189+705+1,440) *** Timestep 52: t=3.25 seconds, dt=0.0625 seconds Skipping temperature solve because RHS is zero. @@ -511,8 +509,7 @@ Number of degrees of freedom: 4,359 (1,654+222+827+1,656) Postprocessing: Writing graphical output: output-discontinuous_composition_serial_periodic_amr/solution/solution-00052 -Number of active cells: 160 (on 5 levels) -Number of degrees of freedom: 3,744 (1,410+189+705+1,440) +Skipping mesh refinement, because the mesh did not change. *** Timestep 53: t=3.3125 seconds, dt=0.0625 seconds Skipping temperature solve because RHS is zero. diff --git a/tests/discontinuous_composition_serial_periodic_amr/statistics b/tests/discontinuous_composition_serial_periodic_amr/statistics index 5afe07a8246..1241a512b79 100644 --- a/tests/discontinuous_composition_serial_periodic_amr/statistics +++ b/tests/discontinuous_composition_serial_periodic_amr/statistics @@ -31,7 +31,7 @@ 20 1.250000000000e+00 6.250000000000e-02 160 1599 705 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00020 21 1.312500000000e+00 6.250000000000e-02 160 1599 705 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00021 22 1.375000000000e+00 6.250000000000e-02 160 1599 705 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00022 -23 1.437500000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00023 +23 1.437500000000e+00 6.250000000000e-02 160 1599 705 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00023 24 1.500000000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00024 25 1.562500000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00025 26 1.625000000000e+00 6.250000000000e-02 148 1578 695 1332 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00026 @@ -39,7 +39,7 @@ 28 1.750000000000e+00 6.250000000000e-02 148 1578 695 1332 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00028 29 1.812500000000e+00 6.250000000000e-02 160 1655 729 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00029 30 1.875000000000e+00 6.250000000000e-02 148 1578 695 1332 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00030 -31 1.937500000000e+00 6.250000000000e-02 160 1655 729 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00031 +31 1.937500000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00031 32 2.000000000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00032 33 2.062500000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00033 34 2.125000000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00034 @@ -59,8 +59,8 @@ 48 3.000000000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00048 49 3.062500000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00049 50 3.125000000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00050 -51 3.187500000000e+00 6.250000000000e-02 160 1599 705 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00051 -52 3.250000000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00052 +51 3.187500000000e+00 6.250000000000e-02 184 1876 827 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00051 +52 3.250000000000e+00 6.250000000000e-02 160 1599 705 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00052 53 3.312500000000e+00 6.250000000000e-02 160 1599 705 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00053 54 3.375000000000e+00 6.250000000000e-02 160 1599 705 1440 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00054 55 3.437500000000e+00 6.250000000000e-02 184 1820 803 1656 0 2 output-discontinuous_composition_serial_periodic_amr/solution/solution-00055 diff --git a/tests/refinement_composition_gradient/screen-output b/tests/refinement_composition_gradient/screen-output index e419c252fb6..c7627c76c7c 100644 --- a/tests/refinement_composition_gradient/screen-output +++ b/tests/refinement_composition_gradient/screen-output @@ -48,8 +48,8 @@ Number of degrees of freedom: 10,979 (4,178+534+2,089+2,089+2,089) Temperature min/avg/max: 0.07297 K, 0.1773 K, 0.5382 K Compositions min/max/mass: 0.03042/1.06/0.1694 // 1/1.985/1.156 -Number of active cells: 898 (on 7 levels) -Number of degrees of freedom: 20,589 (7,838+994+3,919+3,919+3,919) +Number of active cells: 895 (on 7 levels) +Number of degrees of freedom: 20,526 (7,814+991+3,907+3,907+3,907) *** Timestep 4: t=0.0726343 seconds, dt=0.0153574 seconds Solving temperature system... 30 iterations. @@ -59,7 +59,7 @@ Number of degrees of freedom: 20,589 (7,838+994+3,919+3,919+3,919) Postprocessing: Writing graphical output: output-refinement_composition_gradient/solution/solution-00004 Temperature min/avg/max: 0.07521 K, 0.1772 K, 0.5356 K - Compositions min/max/mass: 0.01983/1.058/0.1695 // 1/1.987/1.156 + Compositions min/max/mass: 0.01988/1.058/0.1695 // 1/1.987/1.156 *** Timestep 5: t=0.08 seconds, dt=0.00736566 seconds Solving temperature system... 15 iterations. @@ -69,7 +69,7 @@ Number of degrees of freedom: 20,589 (7,838+994+3,919+3,919+3,919) Postprocessing: Writing graphical output: output-refinement_composition_gradient/solution/solution-00005 Temperature min/avg/max: 0.07608 K, 0.1772 K, 0.5337 K - Compositions min/max/mass: 0.01586/1.055/0.1695 // 1/1.987/1.156 + Compositions min/max/mass: 0.01592/1.055/0.1695 // 1/1.987/1.156 Termination requested by criterion: end time diff --git a/tests/refinement_composition_gradient/solution/solution-00004.0000.gnuplot b/tests/refinement_composition_gradient/solution/solution-00004.0000.gnuplot index 7a896cd1709..94bffb9ebb5 100644 --- a/tests/refinement_composition_gradient/solution/solution-00004.0000.gnuplot +++ b/tests/refinement_composition_gradient/solution/solution-00004.0000.gnuplot @@ -61,196 +61,210 @@ 1 1 -1 1 0 0.1 0.1 1.00006 7.19277 -0 0 0 0 0 0.1 0.997232 1.0003 0.00269019 -0.0625 0 0 0.0625 0 0.1 1.00151 1.00096 0.00269019 +0 0 0 0 0 0.1 0.997233 1.0003 0.00269019 +0.0625 0 0 0.0625 0 0.1 1.00152 1.00096 0.00269019 -0 0.0625 -0.0625 0 0 0.1 1.00111 1.00074 0.00269019 -0.0625 0.0625 -0.0625 0.0625 0 0.1 0.999436 1.00229 0.00269019 +0 0.0625 -0.0625 0 0 0.1 1.00112 1.00074 0.00269019 +0.0625 0.0625 -0.0625 0.0625 0 0.1 0.999449 1.00229 0.00269019 -0.0625 0 0 0.0625 0 0.1 1.00151 1.00096 0.0118767 -0.125 0 0 0.125 0 0.1 0.983961 1.0024 0.0118767 +0.0625 0 0 0.0625 0 0.1 1.00152 1.00096 0.0118767 +0.125 0 0 0.125 0 0.1 0.984001 1.0024 0.0118767 -0.0625 0.0625 -0.0625 0.0625 0 0.1 0.999436 1.00229 0.0118767 -0.125 0.0625 -0.0625 0.125 0 0.1 1.00612 1.00575 0.0118767 +0.0625 0.0625 -0.0625 0.0625 0 0.1 0.999449 1.00229 0.0118767 +0.125 0.0625 -0.0625 0.125 0 0.0999999 1.00621 1.00575 0.0118767 -0 0.0625 -0.0625 0 0 0.1 1.00111 1.00074 0.0062989 -0.0625 0.0625 -0.0625 0.0625 0 0.1 0.999436 1.00229 0.0062989 +0 0.0625 -0.0625 0 0 0.1 1.00112 1.00074 0.0062989 +0.0625 0.0625 -0.0625 0.0625 0 0.1 0.999449 1.00229 0.0062989 -0 0.125 -0.125 0 0 0.1 0.995772 1.00175 0.0062989 -0.0625 0.125 -0.125 0.0625 0 0.1 1.00355 1.00553 0.0062989 +0 0.125 -0.125 0 0 0.1 0.995782 1.00175 0.0062989 +0.0625 0.125 -0.125 0.0625 0 0.1 1.00358 1.00553 0.0062989 -0.0625 0.0625 -0.0625 0.0625 0 0.1 0.999436 1.00229 0.0604149 -0.125 0.0625 -0.0625 0.125 0 0.1 1.00612 1.00575 0.0604149 +0.0625 0.0625 -0.0625 0.0625 0 0.1 0.999449 1.00229 0.0604149 +0.125 0.0625 -0.0625 0.125 0 0.0999999 1.00621 1.00575 0.0604149 -0.0625 0.125 -0.125 0.0625 0 0.1 1.00355 1.00553 0.0604149 -0.125 0.125 -0.125 0.125 0 0.0999999 0.973773 1.01356 0.0604149 +0.0625 0.125 -0.125 0.0625 0 0.1 1.00358 1.00553 0.0604149 +0.125 0.125 -0.125 0.125 0 0.0999998 0.974063 1.01356 0.0604149 -0.125 0 0 0.125 0 0.1 0.983961 1.0024 0.277414 -0.1875 0 0 0.1875 0 0.1 0.993897 1.00557 0.277414 +0.125 0 0 0.125 0 0.1 0.984001 1.0024 0.277414 +0.1875 0 0 0.1875 0 0.1 0.993984 1.00557 0.277414 -0.125 0.0625 -0.0625 0.125 0 0.1 1.00612 1.00575 0.277414 -0.1875 0.0625 -0.0625 0.1875 0 0.0999987 0.996904 1.01295 0.277414 +0.125 0.0625 -0.0625 0.125 0 0.0999999 1.00621 1.00575 0.277414 +0.1875 0.0625 -0.0625 0.1875 0 0.0999984 0.997093 1.01295 0.277414 -0.1875 0 0 0.1875 0 0.1 0.993897 1.00557 1.25115 -0.25 0 0 0.25 0 0.1 0.977337 1.01115 1.25115 +0.1875 0 0 0.1875 0 0.1 0.993984 1.00557 1.25115 +0.25 0 0 0.25 0 0.1 0.978037 1.01116 1.25115 -0.1875 0.0625 -0.0625 0.1875 0 0.0999987 0.996904 1.01295 1.25115 -0.25 0.0625 -0.0625 0.25 0 0.0999984 0.982506 1.02423 1.25115 +0.1875 0.0625 -0.0625 0.1875 0 0.0999984 0.997093 1.01295 1.25115 +0.25 0.0625 -0.0625 0.25 0 0.0999963 0.983966 1.02424 1.25115 -0.125 0.0625 -0.0625 0.125 0 0.1 1.00612 1.00575 0.927172 -0.1875 0.0625 -0.0625 0.1875 0 0.0999987 0.996904 1.01295 0.927172 +0.125 0.0625 -0.0625 0.125 0 0.0999999 1.00621 1.00575 0.927172 +0.1875 0.0625 -0.0625 0.1875 0 0.0999984 0.997093 1.01295 0.927172 -0.125 0.125 -0.125 0.125 0 0.0999999 0.973773 1.01356 0.927172 -0.1875 0.125 -0.125 0.1875 0 0.0999963 0.978022 1.03008 0.927172 +0.125 0.125 -0.125 0.125 0 0.0999998 0.974063 1.01356 0.927172 +0.1875 0.125 -0.125 0.1875 0 0.0999954 0.977955 1.03008 0.927172 -0.1875 0.0625 -0.0625 0.1875 0 0.0999987 0.996904 1.01295 4.15234 -0.25 0.0625 -0.0625 0.25 0 0.0999984 0.982506 1.02423 4.15234 +0.1875 0.0625 -0.0625 0.1875 0 0.0999984 0.997093 1.01295 4.15234 +0.25 0.0625 -0.0625 0.25 0 0.0999963 0.983966 1.02424 4.15234 -0.1875 0.125 -0.125 0.1875 0 0.0999963 0.978022 1.03008 4.15234 -0.25 0.125 -0.125 0.25 0 0.099995 0.939236 1.05628 4.15234 +0.1875 0.125 -0.125 0.1875 0 0.0999954 0.977955 1.03008 4.15234 +0.25 0.125 -0.125 0.25 0 0.0999887 0.939747 1.05628 4.15234 -0 0.125 -0.125 0 0 0.1 0.995772 1.00175 0.00722184 -0.0625 0.125 -0.125 0.0625 0 0.1 1.00355 1.00553 0.00722184 +0 0.125 -0.125 0 0 0.1 0.995782 1.00175 0.00722184 +0.0625 0.125 -0.125 0.0625 0 0.1 1.00358 1.00553 0.00722184 -0 0.1875 -0.1875 0 0 0.1 1.00352 1.00354 0.00722184 -0.0625 0.1875 -0.1875 0.0625 0 0.1 0.998682 1.01111 0.00722184 +0 0.1875 -0.1875 0 0 0.1 1.00356 1.00354 0.00722184 +0.0625 0.1875 -0.1875 0.0625 0 0.1 0.998876 1.01111 0.00722184 -0.0625 0.125 -0.125 0.0625 0 0.1 1.00355 1.00553 0.0526679 -0.125 0.125 -0.125 0.125 0 0.0999999 0.973773 1.01356 0.0526679 +0.0625 0.125 -0.125 0.0625 0 0.1 1.00358 1.00553 0.0526679 +0.125 0.125 -0.125 0.125 0 0.0999998 0.974063 1.01356 0.0526679 -0.0625 0.1875 -0.1875 0.0625 0 0.1 0.998682 1.01111 0.0526679 -0.125 0.1875 -0.1875 0.125 0 0.100001 1.02966 1.02691 0.0526679 +0.0625 0.1875 -0.1875 0.0625 0 0.1 0.998876 1.01111 0.0526679 +0.125 0.1875 -0.1875 0.125 0 0.100001 1.03115 1.02692 0.0526679 -0 0.1875 -0.1875 0 0 0.1 1.00352 1.00354 0.0934159 -0.0625 0.1875 -0.1875 0.0625 0 0.1 0.998682 1.01111 0.0934159 +0 0.1875 -0.1875 0 0 0.1 1.00356 1.00354 0.0934159 +0.0625 0.1875 -0.1875 0.0625 0 0.1 0.998876 1.01111 0.0934159 -0 0.25 -0.25 0 0 0.1 0.991865 1.00598 0.0934159 -0.0625 0.25 -0.25 0.0625 0 0.1 1.00234 1.01886 0.0934159 +0 0.25 -0.25 0 0 0.1 0.991819 1.00598 0.0934159 +0.0625 0.25 -0.25 0.0625 0 0.1 1.00209 1.01886 0.0934159 -0.0625 0.1875 -0.1875 0.0625 0 0.1 0.998682 1.01111 0.255881 -0.125 0.1875 -0.1875 0.125 0 0.100001 1.02966 1.02691 0.255881 +0.0625 0.1875 -0.1875 0.0625 0 0.1 0.998876 1.01111 0.255881 +0.125 0.1875 -0.1875 0.125 0 0.100001 1.03115 1.02692 0.255881 -0.0625 0.25 -0.25 0.0625 0 0.1 1.00234 1.01886 0.255881 -0.125 0.25 -0.25 0.125 0 0.100001 0.745287 1.04613 0.255881 +0.0625 0.25 -0.25 0.0625 0 0.1 1.00209 1.01886 0.255881 +0.125 0.25 -0.25 0.125 0 0.100002 0.742775 1.04618 0.255881 -0.125 0.125 -0.125 0.125 0 0.0999999 0.973773 1.01356 1.83012 -0.1875 0.125 -0.125 0.1875 0 0.0999963 0.978022 1.03008 1.83012 +0.125 0.125 -0.125 0.125 0 0.0999998 0.974063 1.01356 1.83012 +0.1875 0.125 -0.125 0.1875 0 0.0999954 0.977955 1.03008 1.83012 -0.125 0.1875 -0.1875 0.125 0 0.100001 1.02966 1.02691 1.83012 -0.1875 0.1875 -0.1875 0.1875 0 0.0999922 0.850175 1.05991 1.83012 +0.125 0.1875 -0.1875 0.125 0 0.100001 1.03115 1.02692 1.83012 +0.1875 0.1875 -0.1875 0.1875 0 0.0999916 0.849371 1.05991 1.83012 -0.25 0 0 0.25 0 0.1 0.977337 1.01115 53.4313 -0.3125 0 0 0.3125 0 0.1 0.928187 1.01905 53.4313 +0.125 0.1875 -0.1875 0.125 0 0.100001 1.03115 1.02692 2.73217 +0.1875 0.1875 -0.1875 0.1875 0 0.0999916 0.849371 1.05991 2.73217 -0.25 0.0625 -0.0625 0.25 0 0.0999984 0.982506 1.02423 53.4313 -0.3125 0.0625 -0.0625 0.3125 0 0.100174 0.983867 1.03861 53.4313 +0.125 0.25 -0.25 0.125 0 0.100002 0.742775 1.04618 2.73217 +0.1875 0.25 -0.25 0.1875 0 0.0999818 0.0825895 1.10243 2.73217 -0.3125 0 0 0.3125 0 0.1 0.928187 1.01905 76.0198 -0.375 0 0 0.375 0 0.1 0.908357 1.02753 76.0198 +0.25 0 0 0.25 0 0.1 0.978037 1.01116 53.4313 +0.3125 0 0 0.3125 0 0.1 0.929653 1.01906 53.4313 -0.3125 0.0625 -0.0625 0.3125 0 0.100174 0.983867 1.03861 76.0198 -0.375 0.0625 -0.0625 0.375 0 0.100089 0.236609 1.05256 76.0198 +0.25 0.0625 -0.0625 0.25 0 0.0999963 0.983966 1.02424 53.4313 +0.3125 0.0625 -0.0625 0.3125 0 0.100208 0.986852 1.03861 53.4313 -0.375 0 0 0.375 0 0.1 0.908357 1.02753 69.161 -0.4375 0 0 0.4375 0 0.1 0.0198283 1.0347 69.161 +0.3125 0 0 0.3125 0 0.1 0.929653 1.01906 76.0198 +0.375 0 0 0.375 0 0.1 0.908547 1.02753 76.0198 -0.375 0.0625 -0.0625 0.375 0 0.100089 0.236609 1.05256 69.161 -0.4375 0.0625 -0.0625 0.4375 0 0.0998641 0.100111 1.06179 69.161 +0.3125 0.0625 -0.0625 0.3125 0 0.100208 0.986852 1.03861 76.0198 +0.375 0.0625 -0.0625 0.375 0 0.100096 0.237072 1.05256 76.0198 -0.4375 0 0 0.4375 0 0.1 0.0198283 1.0347 98.7004 -0.5 0 0 0.5 0 0.1 0.0933372 1.03764 98.7004 +0.25 0.0625 -0.0625 0.25 0 0.0999963 0.983966 1.02424 111.659 +0.3125 0.0625 -0.0625 0.3125 0 0.100208 0.986852 1.03861 111.659 -0.4375 0.0625 -0.0625 0.4375 0 0.0998641 0.100111 1.06179 98.7004 -0.5 0.0625 -0.0625 0.5 0 0.0997804 0.100301 1.06236 98.7004 +0.25 0.125 -0.125 0.25 0 0.0999887 0.939747 1.05628 111.659 +0.3125 0.125 -0.125 0.3125 0 0.100495 0.145875 1.08978 111.659 -0 0.25 -0.25 0 0 0.1 0.991865 1.00598 1.14785 -0.0625 0.25 -0.25 0.0625 0 0.1 1.00234 1.01886 1.14785 +0.375 0 0 0.375 0 0.1 0.908547 1.02753 69.161 +0.4375 0 0 0.4375 0 0.1 0.0198756 1.0347 69.161 -0 0.3125 -0.3125 0 0 0.1 1.01874 1.00938 1.14785 -0.0625 0.3125 -0.3125 0.0625 0 0.100001 0.515342 1.0272 1.14785 +0.375 0.0625 -0.0625 0.375 0 0.100096 0.237072 1.05256 69.161 +0.4375 0.0625 -0.0625 0.4375 0 0.0998649 0.100189 1.06179 69.161 -0.0625 0.25 -0.25 0.0625 0 0.1 1.00234 1.01886 2.69124 -0.125 0.25 -0.25 0.125 0 0.100001 0.745287 1.04613 2.69124 +0.4375 0 0 0.4375 0 0.1 0.0198756 1.0347 98.7004 +0.5 0 0 0.5 0 0.1 0.0933463 1.03764 98.7004 -0.0625 0.3125 -0.3125 0.0625 0 0.100001 0.515342 1.0272 2.69124 -0.125 0.3125 -0.3125 0.125 0 0.0999895 0.0759783 1.06914 2.69124 +0.4375 0.0625 -0.0625 0.4375 0 0.0998649 0.100189 1.06179 98.7004 +0.5 0.0625 -0.0625 0.5 0 0.0997806 0.100315 1.06236 98.7004 -0 0.3125 -0.3125 0 0 0.1 1.01874 1.00938 5.38602 -0.0625 0.3125 -0.3125 0.0625 0 0.100001 0.515342 1.0272 5.38602 +0 0.25 -0.25 0 0 0.1 0.991819 1.00598 1.14785 +0.0625 0.25 -0.25 0.0625 0 0.1 1.00209 1.01886 1.14785 -0 0.375 -0.375 0 0 0.1 0.318651 1.0118 5.38602 -0.0625 0.375 -0.375 0.0625 0 0.0999908 0.0716137 1.03439 5.38602 +0 0.3125 -0.3125 0 0 0.1 1.01873 1.00938 1.14785 +0.0625 0.3125 -0.3125 0.0625 0 0.100001 0.515299 1.0272 1.14785 -0.0625 0.3125 -0.3125 0.0625 0 0.100001 0.515342 1.0272 7.90926 -0.125 0.3125 -0.3125 0.125 0 0.0999895 0.0759783 1.06914 7.90926 +0.0625 0.25 -0.25 0.0625 0 0.1 1.00209 1.01886 2.69124 +0.125 0.25 -0.25 0.125 0 0.100002 0.742775 1.04618 2.69124 -0.0625 0.375 -0.375 0.0625 0 0.0999908 0.0716137 1.03439 7.90926 -0.125 0.375 -0.375 0.125 0 0.10005 0.0823468 1.08696 7.90926 +0.0625 0.3125 -0.3125 0.0625 0 0.100001 0.515299 1.0272 2.69124 +0.125 0.3125 -0.3125 0.125 0 0.0999897 0.0756172 1.06914 2.69124 -0 0.375 -0.375 0 0 0.1 0.318651 1.0118 19.9518 -0.0625 0.375 -0.375 0.0625 0 0.0999908 0.0716137 1.03439 19.9518 +0 0.3125 -0.3125 0 0 0.1 1.01873 1.00938 5.38602 +0.0625 0.3125 -0.3125 0.0625 0 0.100001 0.515299 1.0272 5.38602 + +0 0.375 -0.375 0 0 0.1 0.318649 1.0118 5.38602 +0.0625 0.375 -0.375 0.0625 0 0.0999908 0.0716075 1.03439 5.38602 + + +0.0625 0.3125 -0.3125 0.0625 0 0.100001 0.515299 1.0272 7.90926 +0.125 0.3125 -0.3125 0.125 0 0.0999897 0.0756172 1.06914 7.90926 + +0.0625 0.375 -0.375 0.0625 0 0.0999908 0.0716075 1.03439 7.90926 +0.125 0.375 -0.375 0.125 0 0.10005 0.0822996 1.08696 7.90926 + + +0 0.375 -0.375 0 0 0.1 0.318649 1.0118 19.9518 +0.0625 0.375 -0.375 0.0625 0 0.0999908 0.0716075 1.03439 19.9518 0 0.4375 -0.4375 0 0 0.1 0.105205 1.0128 19.9518 -0.0625 0.4375 -0.4375 0.0625 0 0.100034 0.0972885 1.0372 19.9518 +0.0625 0.4375 -0.4375 0.0625 0 0.100034 0.0972875 1.0372 19.9518 -0.0625 0.375 -0.375 0.0625 0 0.0999908 0.0716137 1.03439 45.9725 -0.125 0.375 -0.375 0.125 0 0.10005 0.0823468 1.08696 45.9725 +0.0625 0.375 -0.375 0.0625 0 0.0999908 0.0716075 1.03439 45.9725 +0.125 0.375 -0.375 0.125 0 0.10005 0.0822996 1.08696 45.9725 -0.0625 0.4375 -0.4375 0.0625 0 0.100034 0.0972885 1.0372 45.9725 -0.125 0.4375 -0.4375 0.125 0 0.100052 0.099107 1.09357 45.9725 +0.0625 0.4375 -0.4375 0.0625 0 0.100034 0.0972875 1.0372 45.9725 +0.125 0.4375 -0.4375 0.125 0 0.100052 0.0991 1.09357 45.9725 0 0.4375 -0.4375 0 0 0.1 0.105205 1.0128 20.7626 -0.0625 0.4375 -0.4375 0.0625 0 0.100034 0.0972885 1.0372 20.7626 +0.0625 0.4375 -0.4375 0.0625 0 0.100034 0.0972875 1.0372 20.7626 0 0.5 -0.5 0 0 0.1 0.0999482 1.01158 20.7626 0.0625 0.5 -0.5 0.0625 0 0.100035 0.100557 1.03512 20.7626 -0.0625 0.4375 -0.4375 0.0625 0 0.100034 0.0972885 1.0372 86.4768 -0.125 0.4375 -0.4375 0.125 0 0.100052 0.099107 1.09357 86.4768 +0.0625 0.4375 -0.4375 0.0625 0 0.100034 0.0972875 1.0372 86.4768 +0.125 0.4375 -0.4375 0.125 0 0.100052 0.0991 1.09357 86.4768 0.0625 0.5 -0.5 0.0625 0 0.100035 0.100557 1.03512 86.4768 -0.125 0.5 -0.5 0.125 0 0.100415 0.100119 1.08562 86.4768 +0.125 0.5 -0.5 0.125 0 0.100415 0.100118 1.08562 86.4768 -0.5 0 0 0.5 0 0.1 0.0933372 1.03764 161.31 -0.5625 0 0 0.5625 0 0.1 0.0995227 1.03468 161.31 +0.5 0 0 0.5 0 0.1 0.0933463 1.03764 161.31 +0.5625 0 0 0.5625 0 0.1 0.0995245 1.03468 161.31 -0.5 0.0625 -0.0625 0.5 0 0.0997804 0.100301 1.06236 161.31 -0.5625 0.0625 -0.0625 0.5625 0 0.0996904 0.100077 1.05391 161.31 +0.5 0.0625 -0.0625 0.5 0 0.0997806 0.100315 1.06236 161.31 +0.5625 0.0625 -0.0625 0.5625 0 0.0996905 0.100079 1.05391 161.31 -0.5625 0 0 0.5625 0 0.1 0.0995227 1.03468 199.13 -0.625 0 0 0.625 0 0.1 0.0999881 1.02835 199.13 +0.5625 0 0 0.5625 0 0.1 0.0995245 1.03468 199.13 +0.625 0 0 0.625 0 0.1 0.0999884 1.02835 199.13 -0.5625 0.0625 -0.0625 0.5625 0 0.0996904 0.100077 1.05391 199.13 +0.5625 0.0625 -0.0625 0.5625 0 0.0996905 0.100079 1.05391 199.13 0.625 0.0625 -0.0625 0.625 0 0.100378 0.100014 1.04028 199.13 -0.625 0 0 0.625 0 0.1 0.0999881 1.02835 307.211 +0.625 0 0 0.625 0 0.1 0.0999884 1.02835 307.211 0.6875 0 0 0.6875 0 0.1 0.100006 1.02042 307.211 0.625 0.0625 -0.0625 0.625 0 0.100378 0.100014 1.04028 307.211 @@ -447,10 +461,10 @@ 0.0625 0.5 -0.5 0.0625 0 0.100035 0.100557 1.03512 165.728 -0.125 0.5 -0.5 0.125 0 0.100415 0.100119 1.08562 165.728 +0.125 0.5 -0.5 0.125 0 0.100415 0.100118 1.08562 165.728 0.0625 0.5625 -0.5625 0.0625 0 0.100052 0.100016 1.02819 165.728 -0.125 0.5625 -0.5625 0.125 0 0.100754 0.100063 1.06777 165.728 +0.125 0.5625 -0.5625 0.125 0 0.100754 0.100062 1.06777 165.728 0 0.5625 -0.5625 0 0 0.1 0.0999793 1.00959 15.4103 @@ -461,7 +475,7 @@ 0.0625 0.5625 -0.5625 0.0625 0 0.100052 0.100016 1.02819 218.548 -0.125 0.5625 -0.5625 0.125 0 0.100754 0.100063 1.06777 218.548 +0.125 0.5625 -0.5625 0.125 0 0.100754 0.100062 1.06777 218.548 0.0625 0.625 -0.625 0.0625 0 0.100094 0.100036 1.01914 218.548 0.125 0.625 -0.625 0.125 0 0.100908 0.0999875 1.04633 218.548 @@ -803,676 +817,613 @@ 1 0.875 -0.875 1 0 0.1 0.1 1.00011 18.9878 -0.1875 0.125 -0.125 0.1875 0 0.0999963 0.978022 1.03008 0.832747 -0.21875 0.125 -0.125 0.21875 0 0.100011 0.996144 1.0418 0.832747 - -0.1875 0.15625 -0.15625 0.1875 0 0.100002 1.05781 1.04315 0.832747 -0.21875 0.15625 -0.15625 0.21875 0 0.0999959 0.871117 1.0601 0.832747 - - -0.21875 0.125 -0.125 0.21875 0 0.100011 0.996144 1.0418 1.52596 -0.25 0.125 -0.125 0.25 0 0.099995 0.939236 1.05628 1.52596 - -0.21875 0.15625 -0.15625 0.21875 0 0.0999959 0.871117 1.0601 1.52596 -0.25 0.15625 -0.15625 0.25 0 0.0999942 0.385489 1.08106 1.52596 - - -0.1875 0.15625 -0.15625 0.1875 0 0.100002 1.05781 1.04315 3.09563 -0.21875 0.15625 -0.15625 0.21875 0 0.0999959 0.871117 1.0601 3.09563 - -0.1875 0.1875 -0.1875 0.1875 0 0.0999922 0.850175 1.05991 3.09563 -0.21875 0.1875 -0.1875 0.21875 0 0.100037 0.40866 1.08355 3.09563 - - -0.21875 0.15625 -0.15625 0.21875 0 0.0999959 0.871117 1.0601 3.29596 -0.25 0.15625 -0.15625 0.25 0 0.0999942 0.385489 1.08106 3.29596 - -0.21875 0.1875 -0.1875 0.21875 0 0.100037 0.40866 1.08355 3.29596 -0.25 0.1875 -0.1875 0.25 0 0.0999797 0.0872394 1.11218 3.29596 - - -0.125 0.1875 -0.1875 0.125 0 0.100001 1.02966 1.02691 0.0578572 -0.15625 0.1875 -0.1875 0.15625 0 0.0999999 0.980359 1.04165 0.0578572 - -0.125 0.21875 -0.21875 0.125 0 0.0999994 0.989514 1.0358 0.0578572 -0.15625 0.21875 -0.21875 0.15625 0 0.0999999 0.779725 1.05548 0.0578572 - - -0.15625 0.1875 -0.1875 0.15625 0 0.0999999 0.980359 1.04165 0.262643 -0.1875 0.1875 -0.1875 0.1875 0 0.0999922 0.850175 1.05991 0.262643 - -0.15625 0.21875 -0.21875 0.15625 0 0.0999999 0.779725 1.05548 0.262643 -0.1875 0.21875 -0.21875 0.1875 0 0.100004 0.250001 1.07984 0.262643 - +0.1875 0.125 -0.125 0.1875 0 0.0999954 0.977955 1.03008 0.832747 +0.21875 0.125 -0.125 0.21875 0 0.100012 0.996106 1.0418 0.832747 -0.125 0.21875 -0.21875 0.125 0 0.0999994 0.989514 1.0358 0.296272 -0.15625 0.21875 -0.21875 0.15625 0 0.0999999 0.779725 1.05548 0.296272 +0.1875 0.15625 -0.15625 0.1875 0 0.100002 1.05793 1.04315 0.832747 +0.21875 0.15625 -0.15625 0.21875 0 0.099996 0.871136 1.0601 0.832747 -0.125 0.25 -0.25 0.125 0 0.100001 0.745287 1.04613 0.296272 -0.15625 0.25 -0.25 0.15625 0 0.100002 0.258961 1.07141 0.296272 +0.21875 0.125 -0.125 0.21875 0 0.100012 0.996106 1.0418 1.52596 +0.25 0.125 -0.125 0.25 0 0.0999887 0.939747 1.05628 1.52596 -0.15625 0.21875 -0.21875 0.15625 0 0.0999999 0.779725 1.05548 1.11174 -0.1875 0.21875 -0.21875 0.1875 0 0.100004 0.250001 1.07984 1.11174 +0.21875 0.15625 -0.15625 0.21875 0 0.099996 0.871136 1.0601 1.52596 +0.25 0.15625 -0.15625 0.25 0 0.0999937 0.385488 1.08106 1.52596 -0.15625 0.25 -0.25 0.15625 0 0.100002 0.258961 1.07141 1.11174 -0.1875 0.25 -0.25 0.1875 0 0.0999859 0.0858224 1.10254 1.11174 +0.1875 0.15625 -0.15625 0.1875 0 0.100002 1.05793 1.04315 3.09563 +0.21875 0.15625 -0.15625 0.21875 0 0.099996 0.871136 1.0601 3.09563 -0.1875 0.1875 -0.1875 0.1875 0 0.0999922 0.850175 1.05991 1.50343 -0.21875 0.1875 -0.1875 0.21875 0 0.100037 0.40866 1.08355 1.50343 +0.1875 0.1875 -0.1875 0.1875 0 0.0999916 0.849371 1.05991 3.09563 +0.21875 0.1875 -0.1875 0.21875 0 0.100037 0.408525 1.08355 3.09563 -0.1875 0.21875 -0.21875 0.1875 0 0.100004 0.250001 1.07984 1.50343 -0.21875 0.21875 -0.21875 0.21875 0 0.100021 0.122745 1.11153 1.50343 +0.21875 0.15625 -0.15625 0.21875 0 0.099996 0.871136 1.0601 3.29596 +0.25 0.15625 -0.15625 0.25 0 0.0999937 0.385488 1.08106 3.29596 -0.21875 0.1875 -0.1875 0.21875 0 0.100037 0.40866 1.08355 4.63285 -0.25 0.1875 -0.1875 0.25 0 0.0999797 0.0872394 1.11218 4.63285 +0.21875 0.1875 -0.1875 0.21875 0 0.100037 0.408525 1.08355 3.29596 +0.25 0.1875 -0.1875 0.25 0 0.0999796 0.0872183 1.11218 3.29596 -0.21875 0.21875 -0.21875 0.21875 0 0.100021 0.122745 1.11153 4.63285 -0.25 0.21875 -0.21875 0.25 0 0.0999895 0.0916972 1.15006 4.63285 +0.1875 0.1875 -0.1875 0.1875 0 0.0999916 0.849371 1.05991 1.50343 +0.21875 0.1875 -0.1875 0.21875 0 0.100037 0.408525 1.08355 1.50343 -0.1875 0.21875 -0.21875 0.1875 0 0.100004 0.250001 1.07984 8.76671 -0.21875 0.21875 -0.21875 0.21875 0 0.100021 0.122745 1.11153 8.76671 +0.1875 0.21875 -0.21875 0.1875 0 0.100005 0.256864 1.07979 1.50343 +0.21875 0.21875 -0.21875 0.21875 0 0.100021 0.124119 1.11151 1.50343 -0.1875 0.25 -0.25 0.1875 0 0.0999859 0.0858224 1.10254 8.76671 -0.21875 0.25 -0.25 0.21875 0 0.100158 0.0990889 1.14305 8.76671 +0.21875 0.1875 -0.1875 0.21875 0 0.100037 0.408525 1.08355 4.63285 +0.25 0.1875 -0.1875 0.25 0 0.0999796 0.0872183 1.11218 4.63285 -0.21875 0.21875 -0.21875 0.21875 0 0.100021 0.122745 1.11153 28.1915 -0.25 0.21875 -0.21875 0.25 0 0.0999895 0.0916972 1.15006 28.1915 +0.21875 0.21875 -0.21875 0.21875 0 0.100021 0.124119 1.11151 4.63285 +0.25 0.21875 -0.21875 0.25 0 0.0999895 0.0919813 1.15006 4.63285 -0.21875 0.25 -0.25 0.21875 0 0.100158 0.0990889 1.14305 28.1915 -0.25 0.25 -0.25 0.25 0 0.0999125 0.102361 1.19145 28.1915 +0.1875 0.21875 -0.21875 0.1875 0 0.100005 0.256864 1.07979 8.76671 +0.21875 0.21875 -0.21875 0.21875 0 0.100021 0.124119 1.11151 8.76671 -0.25 0.0625 -0.0625 0.25 0 0.0999984 0.982506 1.02423 0.847911 -0.28125 0.0625 -0.0625 0.28125 0 0.10002 0.989951 1.03102 0.847911 +0.1875 0.25 -0.25 0.1875 0 0.0999818 0.0825895 1.10243 8.76671 +0.21875 0.25 -0.25 0.21875 0 0.100157 0.0982873 1.14302 8.76671 -0.25 0.09375 -0.09375 0.25 0 0.100001 1.04349 1.03744 0.847911 -0.28125 0.09375 -0.09375 0.28125 0 0.0999956 0.947889 1.04803 0.847911 +0.21875 0.21875 -0.21875 0.21875 0 0.100021 0.124119 1.11151 28.1915 +0.25 0.21875 -0.21875 0.25 0 0.0999895 0.0919813 1.15006 28.1915 -0.28125 0.0625 -0.0625 0.28125 0 0.10002 0.989951 1.03102 13.6659 -0.3125 0.0625 -0.0625 0.3125 0 0.100174 0.983867 1.03861 13.6659 +0.21875 0.25 -0.25 0.21875 0 0.100157 0.0982873 1.14302 28.1915 +0.25 0.25 -0.25 0.25 0 0.0999122 0.102162 1.19144 28.1915 -0.28125 0.09375 -0.09375 0.28125 0 0.0999956 0.947889 1.04803 13.6659 -0.3125 0.09375 -0.09375 0.3125 0 0.0999107 0.515304 1.06007 13.6659 +0.3125 0.0625 -0.0625 0.3125 0 0.100208 0.986852 1.03861 16.9724 +0.34375 0.0625 -0.0625 0.34375 0 0.100133 0.676752 1.04584 16.9724 -0.25 0.09375 -0.09375 0.25 0 0.100001 1.04349 1.03744 2.17701 -0.28125 0.09375 -0.09375 0.28125 0 0.0999956 0.947889 1.04803 2.17701 +0.3125 0.09375 -0.09375 0.3125 0 0.0998355 0.526719 1.06015 16.9724 +0.34375 0.09375 -0.09375 0.34375 0 0.099919 0.238196 1.0714 16.9724 -0.25 0.125 -0.125 0.25 0 0.099995 0.939236 1.05628 2.17701 -0.28125 0.125 -0.125 0.28125 0 0.100081 0.553554 1.07219 2.17701 +0.34375 0.0625 -0.0625 0.34375 0 0.100133 0.676752 1.04584 13.0478 +0.375 0.0625 -0.0625 0.375 0 0.100096 0.237072 1.05256 13.0478 -0.28125 0.09375 -0.09375 0.28125 0 0.0999956 0.947889 1.04803 40.7083 -0.3125 0.09375 -0.09375 0.3125 0 0.0999107 0.515304 1.06007 40.7083 +0.34375 0.09375 -0.09375 0.34375 0 0.099919 0.238196 1.0714 13.0478 +0.375 0.09375 -0.09375 0.375 0 0.0999316 0.112264 1.08262 13.0478 -0.28125 0.125 -0.125 0.28125 0 0.100081 0.553554 1.07219 40.7083 -0.3125 0.125 -0.125 0.3125 0 0.100552 0.146394 1.08975 40.7083 +0.3125 0.09375 -0.09375 0.3125 0 0.0998355 0.526719 1.06015 54.9404 +0.34375 0.09375 -0.09375 0.34375 0 0.099919 0.238196 1.0714 54.9404 -0.3125 0.0625 -0.0625 0.3125 0 0.100174 0.983867 1.03861 16.9724 -0.34375 0.0625 -0.0625 0.34375 0 0.100139 0.677145 1.04584 16.9724 +0.3125 0.125 -0.125 0.3125 0 0.100495 0.145875 1.08978 54.9404 +0.34375 0.125 -0.125 0.34375 0 0.100385 0.0960837 1.10658 54.9404 -0.3125 0.09375 -0.09375 0.3125 0 0.0999107 0.515304 1.06007 16.9724 -0.34375 0.09375 -0.09375 0.34375 0 0.0999376 0.236501 1.07138 16.9724 +0.34375 0.09375 -0.09375 0.34375 0 0.099919 0.238196 1.0714 40.0094 +0.375 0.09375 -0.09375 0.375 0 0.0999316 0.112264 1.08262 40.0094 -0.34375 0.0625 -0.0625 0.34375 0 0.100139 0.677145 1.04584 13.0478 -0.375 0.0625 -0.0625 0.375 0 0.100089 0.236609 1.05256 13.0478 +0.34375 0.125 -0.125 0.34375 0 0.100385 0.0960837 1.10658 40.0094 +0.375 0.125 -0.125 0.375 0 0.100223 0.104975 1.12241 40.0094 -0.34375 0.09375 -0.09375 0.34375 0 0.0999376 0.236501 1.07138 13.0478 -0.375 0.09375 -0.09375 0.375 0 0.0999353 0.111973 1.08261 13.0478 +0.375 0.0625 -0.0625 0.375 0 0.100096 0.237072 1.05256 18.918 +0.40625 0.0625 -0.0625 0.40625 0 0.0998363 0.114138 1.05785 18.918 -0.3125 0.09375 -0.09375 0.3125 0 0.0999107 0.515304 1.06007 54.9404 -0.34375 0.09375 -0.09375 0.34375 0 0.0999376 0.236501 1.07138 54.9404 +0.375 0.09375 -0.09375 0.375 0 0.0999316 0.112264 1.08262 18.918 +0.40625 0.09375 -0.09375 0.40625 0 0.0998472 0.100187 1.09076 18.918 -0.3125 0.125 -0.125 0.3125 0 0.100552 0.146394 1.08975 54.9404 -0.34375 0.125 -0.125 0.34375 0 0.100396 0.0961967 1.10658 54.9404 +0.40625 0.0625 -0.0625 0.40625 0 0.0998363 0.114138 1.05785 23.1584 +0.4375 0.0625 -0.0625 0.4375 0 0.0998649 0.100189 1.06179 23.1584 -0.34375 0.09375 -0.09375 0.34375 0 0.0999376 0.236501 1.07138 40.0094 -0.375 0.09375 -0.09375 0.375 0 0.0999353 0.111973 1.08261 40.0094 +0.40625 0.09375 -0.09375 0.40625 0 0.0998472 0.100187 1.09076 23.1584 +0.4375 0.09375 -0.09375 0.4375 0 0.099826 0.102771 1.09684 23.1584 -0.34375 0.125 -0.125 0.34375 0 0.100396 0.0961967 1.10658 40.0094 -0.375 0.125 -0.125 0.375 0 0.100224 0.104985 1.12241 40.0094 +0.375 0.09375 -0.09375 0.375 0 0.0999316 0.112264 1.08262 74.3637 +0.40625 0.09375 -0.09375 0.40625 0 0.0998472 0.100187 1.09076 74.3637 -0.375 0.0625 -0.0625 0.375 0 0.100089 0.236609 1.05256 18.918 -0.40625 0.0625 -0.0625 0.40625 0 0.0998365 0.114198 1.05785 18.918 +0.375 0.125 -0.125 0.375 0 0.100223 0.104975 1.12241 74.3637 +0.40625 0.125 -0.125 0.40625 0 0.0993818 0.10011 1.13458 74.3637 -0.375 0.09375 -0.09375 0.375 0 0.0999353 0.111973 1.08261 18.918 -0.40625 0.09375 -0.09375 0.40625 0 0.0998434 0.100145 1.09076 18.918 +0.40625 0.09375 -0.09375 0.40625 0 0.0998472 0.100187 1.09076 90.0155 +0.4375 0.09375 -0.09375 0.4375 0 0.099826 0.102771 1.09684 90.0155 -0.40625 0.0625 -0.0625 0.40625 0 0.0998365 0.114198 1.05785 23.1584 -0.4375 0.0625 -0.0625 0.4375 0 0.0998641 0.100111 1.06179 23.1584 +0.40625 0.125 -0.125 0.40625 0 0.0993818 0.10011 1.13458 90.0155 +0.4375 0.125 -0.125 0.4375 0 0.0994372 0.100613 1.14385 90.0155 -0.40625 0.09375 -0.09375 0.40625 0 0.0998434 0.100145 1.09076 23.1584 -0.4375 0.09375 -0.09375 0.4375 0 0.0998243 0.10276 1.09684 23.1584 +0.4375 0.0625 -0.0625 0.4375 0 0.0998649 0.100189 1.06179 27.8304 +0.46875 0.0625 -0.0625 0.46875 0 0.0998025 0.0995722 1.06318 27.8304 -0.375 0.09375 -0.09375 0.375 0 0.0999353 0.111973 1.08261 74.3637 -0.40625 0.09375 -0.09375 0.40625 0 0.0998434 0.100145 1.09076 74.3637 +0.4375 0.09375 -0.09375 0.4375 0 0.099826 0.102771 1.09684 27.8304 +0.46875 0.09375 -0.09375 0.46875 0 0.0997938 0.0998216 1.09888 27.8304 -0.375 0.125 -0.125 0.375 0 0.100224 0.104985 1.12241 74.3637 -0.40625 0.125 -0.125 0.40625 0 0.0993682 0.100107 1.13457 74.3637 +0.46875 0.0625 -0.0625 0.46875 0 0.0998025 0.0995722 1.06318 31.8614 +0.5 0.0625 -0.0625 0.5 0 0.0997806 0.100315 1.06236 31.8614 -0.40625 0.09375 -0.09375 0.40625 0 0.0998434 0.100145 1.09076 90.0155 -0.4375 0.09375 -0.09375 0.4375 0 0.0998243 0.10276 1.09684 90.0155 +0.46875 0.09375 -0.09375 0.46875 0 0.0997938 0.0998216 1.09888 31.8614 +0.5 0.09375 -0.09375 0.5 0 0.0997636 0.100492 1.09737 31.8614 -0.40625 0.125 -0.125 0.40625 0 0.0993682 0.100107 1.13457 90.0155 -0.4375 0.125 -0.125 0.4375 0 0.0994322 0.100611 1.14385 90.0155 +0.4375 0.09375 -0.09375 0.4375 0 0.099826 0.102771 1.09684 102.116 +0.46875 0.09375 -0.09375 0.46875 0 0.0997938 0.0998216 1.09888 102.116 -0.4375 0.0625 -0.0625 0.4375 0 0.0998641 0.100111 1.06179 27.8304 -0.46875 0.0625 -0.0625 0.46875 0 0.0998026 0.0995841 1.06318 27.8304 +0.4375 0.125 -0.125 0.4375 0 0.0994372 0.100613 1.14385 102.116 +0.46875 0.125 -0.125 0.46875 0 0.0993125 0.0999655 1.14683 102.116 -0.4375 0.09375 -0.09375 0.4375 0 0.0998243 0.10276 1.09684 27.8304 -0.46875 0.09375 -0.09375 0.46875 0 0.0997932 0.0998208 1.09888 27.8304 +0.46875 0.09375 -0.09375 0.46875 0 0.0997938 0.0998216 1.09888 114.849 +0.5 0.09375 -0.09375 0.5 0 0.0997636 0.100492 1.09737 114.849 -0.46875 0.0625 -0.0625 0.46875 0 0.0998026 0.0995841 1.06318 31.8614 -0.5 0.0625 -0.0625 0.5 0 0.0997804 0.100301 1.06236 31.8614 +0.46875 0.125 -0.125 0.46875 0 0.0993125 0.0999655 1.14683 114.849 +0.5 0.125 -0.125 0.5 0 0.0992838 0.100105 1.14461 114.849 -0.46875 0.09375 -0.09375 0.46875 0 0.0997932 0.0998208 1.09888 31.8614 -0.5 0.09375 -0.09375 0.5 0 0.0997634 0.100491 1.09737 31.8614 +0.25 0.125 -0.125 0.25 0 0.0999887 0.939747 1.05628 4.16625 +0.28125 0.125 -0.125 0.28125 0 0.100071 0.560717 1.07217 4.16625 -0.4375 0.09375 -0.09375 0.4375 0 0.0998243 0.10276 1.09684 102.116 -0.46875 0.09375 -0.09375 0.46875 0 0.0997932 0.0998208 1.09888 102.116 +0.25 0.15625 -0.15625 0.25 0 0.0999937 0.385488 1.08106 4.16625 +0.28125 0.15625 -0.15625 0.28125 0 0.100052 0.162608 1.10403 4.16625 -0.4375 0.125 -0.125 0.4375 0 0.0994322 0.100611 1.14385 102.116 -0.46875 0.125 -0.125 0.46875 0 0.0993108 0.0999646 1.14683 102.116 +0.28125 0.125 -0.125 0.28125 0 0.100071 0.560717 1.07217 50.4896 +0.3125 0.125 -0.125 0.3125 0 0.100495 0.145875 1.08978 50.4896 -0.46875 0.09375 -0.09375 0.46875 0 0.0997932 0.0998208 1.09888 114.849 -0.5 0.09375 -0.09375 0.5 0 0.0997634 0.100491 1.09737 114.849 +0.28125 0.15625 -0.15625 0.28125 0 0.100052 0.162608 1.10403 50.4896 +0.3125 0.15625 -0.15625 0.3125 0 0.100003 0.0944943 1.12989 50.4896 -0.46875 0.125 -0.125 0.46875 0 0.0993108 0.0999646 1.14683 114.849 -0.5 0.125 -0.125 0.5 0 0.0992833 0.100104 1.14461 114.849 +0.25 0.15625 -0.15625 0.25 0 0.0999937 0.385488 1.08106 15.2388 +0.28125 0.15625 -0.15625 0.28125 0 0.100052 0.162608 1.10403 15.2388 -0.25 0.125 -0.125 0.25 0 0.099995 0.939236 1.05628 4.16625 -0.28125 0.125 -0.125 0.28125 0 0.100081 0.553554 1.07219 4.16625 +0.25 0.1875 -0.1875 0.25 0 0.0999796 0.0872183 1.11218 15.2388 +0.28125 0.1875 -0.1875 0.28125 0 0.100322 0.0917631 1.14403 15.2388 -0.25 0.15625 -0.15625 0.25 0 0.0999942 0.385489 1.08106 4.16625 -0.28125 0.15625 -0.15625 0.28125 0 0.100052 0.162353 1.10403 4.16625 +0.28125 0.15625 -0.15625 0.28125 0 0.100052 0.162608 1.10403 158.594 +0.3125 0.15625 -0.15625 0.3125 0 0.100003 0.0944943 1.12989 158.594 -0.28125 0.125 -0.125 0.28125 0 0.100081 0.553554 1.07219 50.4896 -0.3125 0.125 -0.125 0.3125 0 0.100552 0.146394 1.08975 50.4896 +0.28125 0.1875 -0.1875 0.28125 0 0.100322 0.0917631 1.14403 158.594 +0.3125 0.1875 -0.1875 0.3125 0 0.101829 0.102421 1.17862 158.594 -0.28125 0.15625 -0.15625 0.28125 0 0.100052 0.162353 1.10403 50.4896 -0.3125 0.15625 -0.15625 0.3125 0 0.100007 0.0945911 1.12989 50.4896 +0.3125 0.125 -0.125 0.3125 0 0.100495 0.145875 1.08978 51.3874 +0.34375 0.125 -0.125 0.34375 0 0.100385 0.0960837 1.10658 51.3874 -0.25 0.15625 -0.15625 0.25 0 0.0999942 0.385489 1.08106 15.2388 -0.28125 0.15625 -0.15625 0.28125 0 0.100052 0.162353 1.10403 15.2388 +0.3125 0.15625 -0.15625 0.3125 0 0.100003 0.0944943 1.12989 51.3874 +0.34375 0.15625 -0.15625 0.34375 0 0.100062 0.102831 1.15427 51.3874 -0.25 0.1875 -0.1875 0.25 0 0.0999797 0.0872394 1.11218 15.2388 -0.28125 0.1875 -0.1875 0.28125 0 0.100322 0.0917595 1.14403 15.2388 +0.34375 0.125 -0.125 0.34375 0 0.100385 0.0960837 1.10658 46.6229 +0.375 0.125 -0.125 0.375 0 0.100223 0.104975 1.12241 46.6229 -0.28125 0.15625 -0.15625 0.28125 0 0.100052 0.162353 1.10403 158.594 -0.3125 0.15625 -0.15625 0.3125 0 0.100007 0.0945911 1.12989 158.594 +0.34375 0.15625 -0.15625 0.34375 0 0.100062 0.102831 1.15427 46.6229 +0.375 0.15625 -0.15625 0.375 0 0.0999336 0.100443 1.17864 46.6229 -0.28125 0.1875 -0.1875 0.28125 0 0.100322 0.0917595 1.14403 158.594 -0.3125 0.1875 -0.1875 0.3125 0 0.101829 0.102425 1.17862 158.594 +0.3125 0.15625 -0.15625 0.3125 0 0.100003 0.0944943 1.12989 209.075 +0.34375 0.15625 -0.15625 0.34375 0 0.100062 0.102831 1.15427 209.075 -0.3125 0.125 -0.125 0.3125 0 0.100552 0.146394 1.08975 51.3874 -0.34375 0.125 -0.125 0.34375 0 0.100396 0.0961967 1.10658 51.3874 +0.3125 0.1875 -0.1875 0.3125 0 0.101829 0.102421 1.17862 209.075 +0.34375 0.1875 -0.1875 0.34375 0 0.10124 0.100039 1.21229 209.075 -0.3125 0.15625 -0.15625 0.3125 0 0.100007 0.0945911 1.12989 51.3874 -0.34375 0.15625 -0.15625 0.34375 0 0.100063 0.10285 1.15427 51.3874 +0.34375 0.15625 -0.15625 0.34375 0 0.100062 0.102831 1.15427 150.984 +0.375 0.15625 -0.15625 0.375 0 0.0999336 0.100443 1.17864 150.984 -0.34375 0.125 -0.125 0.34375 0 0.100396 0.0961967 1.10658 46.6229 -0.375 0.125 -0.125 0.375 0 0.100224 0.104985 1.12241 46.6229 +0.34375 0.1875 -0.1875 0.34375 0 0.10124 0.100039 1.21229 150.984 +0.375 0.1875 -0.1875 0.375 0 0.100589 0.100425 1.24418 150.984 -0.34375 0.15625 -0.15625 0.34375 0 0.100063 0.10285 1.15427 46.6229 -0.375 0.15625 -0.15625 0.375 0 0.0999327 0.100447 1.17864 46.6229 +0.25 0.1875 -0.1875 0.25 0 0.0999796 0.0872183 1.11218 14.1911 +0.28125 0.1875 -0.1875 0.28125 0 0.100322 0.0917631 1.14403 14.1911 -0.3125 0.15625 -0.15625 0.3125 0 0.100007 0.0945911 1.12989 209.075 -0.34375 0.15625 -0.15625 0.34375 0 0.100063 0.10285 1.15427 209.075 +0.25 0.21875 -0.21875 0.25 0 0.0999895 0.0919813 1.15006 14.1911 +0.28125 0.21875 -0.21875 0.28125 0 0.100141 0.103653 1.1928 14.1911 -0.3125 0.1875 -0.1875 0.3125 0 0.101829 0.102425 1.17862 209.075 -0.34375 0.1875 -0.1875 0.34375 0 0.10124 0.10004 1.21229 209.075 +0.28125 0.1875 -0.1875 0.28125 0 0.100322 0.0917631 1.14403 161.554 +0.3125 0.1875 -0.1875 0.3125 0 0.101829 0.102421 1.17862 161.554 -0.34375 0.15625 -0.15625 0.34375 0 0.100063 0.10285 1.15427 150.984 -0.375 0.15625 -0.15625 0.375 0 0.0999327 0.100447 1.17864 150.984 +0.28125 0.21875 -0.21875 0.28125 0 0.100141 0.103653 1.1928 161.554 +0.3125 0.21875 -0.21875 0.3125 0 0.099608 0.0980127 1.24119 161.554 -0.34375 0.1875 -0.1875 0.34375 0 0.10124 0.10004 1.21229 150.984 -0.375 0.1875 -0.1875 0.375 0 0.100589 0.100428 1.24418 150.984 +0.25 0.21875 -0.21875 0.25 0 0.0999895 0.0919813 1.15006 56.1353 +0.28125 0.21875 -0.21875 0.28125 0 0.100141 0.103653 1.1928 56.1353 -0.25 0.1875 -0.1875 0.25 0 0.0999797 0.0872394 1.11218 14.1911 -0.28125 0.1875 -0.1875 0.28125 0 0.100322 0.0917595 1.14403 14.1911 +0.25 0.25 -0.25 0.25 0 0.0999122 0.102162 1.19144 56.1353 +0.28125 0.25 -0.25 0.28125 0 0.101049 0.0993885 1.24616 56.1353 -0.25 0.21875 -0.21875 0.25 0 0.0999895 0.0916972 1.15006 14.1911 -0.28125 0.21875 -0.21875 0.28125 0 0.100141 0.103592 1.19281 14.1911 +0.28125 0.21875 -0.21875 0.28125 0 0.100141 0.103653 1.1928 457.593 +0.3125 0.21875 -0.21875 0.3125 0 0.099608 0.0980127 1.24119 457.593 -0.28125 0.1875 -0.1875 0.28125 0 0.100322 0.0917595 1.14403 161.554 -0.3125 0.1875 -0.1875 0.3125 0 0.101829 0.102425 1.17862 161.554 +0.28125 0.25 -0.25 0.28125 0 0.101049 0.0993885 1.24616 457.593 +0.3125 0.25 -0.25 0.3125 0 0.105394 0.100762 1.30532 457.593 -0.28125 0.21875 -0.21875 0.28125 0 0.100141 0.103592 1.19281 161.554 -0.3125 0.21875 -0.21875 0.3125 0 0.0996084 0.0980002 1.24119 161.554 +0.3125 0.1875 -0.1875 0.3125 0 0.101829 0.102421 1.17862 153.517 +0.34375 0.1875 -0.1875 0.34375 0 0.10124 0.100039 1.21229 153.517 -0.25 0.21875 -0.21875 0.25 0 0.0999895 0.0916972 1.15006 56.1353 -0.28125 0.21875 -0.21875 0.28125 0 0.100141 0.103592 1.19281 56.1353 +0.3125 0.21875 -0.21875 0.3125 0 0.099608 0.0980127 1.24119 153.517 +0.34375 0.21875 -0.21875 0.34375 0 0.100055 0.0998945 1.2855 153.517 -0.25 0.25 -0.25 0.25 0 0.0999125 0.102361 1.19145 56.1353 -0.28125 0.25 -0.25 0.28125 0 0.101049 0.0994343 1.24616 56.1353 +0.34375 0.1875 -0.1875 0.34375 0 0.10124 0.100039 1.21229 132.673 +0.375 0.1875 -0.1875 0.375 0 0.100589 0.100425 1.24418 132.673 -0.28125 0.21875 -0.21875 0.28125 0 0.100141 0.103592 1.19281 457.593 -0.3125 0.21875 -0.21875 0.3125 0 0.0996084 0.0980002 1.24119 457.593 +0.34375 0.21875 -0.21875 0.34375 0 0.100055 0.0998945 1.2855 132.673 +0.375 0.21875 -0.21875 0.375 0 0.0998429 0.0995912 1.32548 132.673 -0.28125 0.25 -0.25 0.28125 0 0.101049 0.0994343 1.24616 457.593 -0.3125 0.25 -0.25 0.3125 0 0.105394 0.100771 1.30532 457.593 +0.3125 0.21875 -0.21875 0.3125 0 0.099608 0.0980127 1.24119 648.497 +0.34375 0.21875 -0.21875 0.34375 0 0.100055 0.0998945 1.2855 648.497 -0.3125 0.1875 -0.1875 0.3125 0 0.101829 0.102425 1.17862 153.517 -0.34375 0.1875 -0.1875 0.34375 0 0.10124 0.10004 1.21229 153.517 +0.3125 0.25 -0.25 0.3125 0 0.105394 0.100762 1.30532 648.497 +0.34375 0.25 -0.25 0.34375 0 0.10358 0.099989 1.3621 648.497 -0.3125 0.21875 -0.21875 0.3125 0 0.0996084 0.0980002 1.24119 153.517 -0.34375 0.21875 -0.21875 0.34375 0 0.100059 0.099894 1.2855 153.517 +0.34375 0.21875 -0.21875 0.34375 0 0.100055 0.0998945 1.2855 438.791 +0.375 0.21875 -0.21875 0.375 0 0.0998429 0.0995912 1.32548 438.791 -0.34375 0.1875 -0.1875 0.34375 0 0.10124 0.10004 1.21229 132.673 -0.375 0.1875 -0.1875 0.375 0 0.100589 0.100428 1.24418 132.673 +0.34375 0.25 -0.25 0.34375 0 0.10358 0.099989 1.3621 438.791 +0.375 0.25 -0.25 0.375 0 0.102079 0.100066 1.41792 438.791 -0.34375 0.21875 -0.21875 0.34375 0 0.100059 0.099894 1.2855 132.673 -0.375 0.21875 -0.21875 0.375 0 0.099852 0.0996006 1.3255 132.673 +0.375 0.125 -0.125 0.375 0 0.100223 0.104975 1.12241 71.0905 +0.40625 0.125 -0.125 0.40625 0 0.0993818 0.10011 1.13458 71.0905 -0.3125 0.21875 -0.21875 0.3125 0 0.0996084 0.0980002 1.24119 648.497 -0.34375 0.21875 -0.21875 0.34375 0 0.100059 0.099894 1.2855 648.497 +0.375 0.15625 -0.15625 0.375 0 0.0999336 0.100443 1.17864 71.0905 +0.40625 0.15625 -0.15625 0.40625 0 0.0996106 0.0997082 1.19654 71.0905 -0.3125 0.25 -0.25 0.3125 0 0.105394 0.100771 1.30532 648.497 -0.34375 0.25 -0.25 0.34375 0 0.103571 0.0999891 1.36211 648.497 +0.40625 0.125 -0.125 0.40625 0 0.0993818 0.10011 1.13458 78.8586 +0.4375 0.125 -0.125 0.4375 0 0.0994372 0.100613 1.14385 78.8586 -0.34375 0.21875 -0.21875 0.34375 0 0.100059 0.099894 1.2855 438.791 -0.375 0.21875 -0.21875 0.375 0 0.099852 0.0996006 1.3255 438.791 +0.40625 0.15625 -0.15625 0.40625 0 0.0996106 0.0997082 1.19654 78.8586 +0.4375 0.15625 -0.15625 0.4375 0 0.0994693 0.100212 1.21005 78.8586 -0.34375 0.25 -0.25 0.34375 0 0.103571 0.0999891 1.36211 438.791 -0.375 0.25 -0.25 0.375 0 0.101953 0.100065 1.41803 438.791 +0.375 0.15625 -0.15625 0.375 0 0.0999336 0.100443 1.17864 265.493 +0.40625 0.15625 -0.15625 0.40625 0 0.0996106 0.0997082 1.19654 265.493 -0.375 0.125 -0.125 0.375 0 0.100224 0.104985 1.12241 71.0905 -0.40625 0.125 -0.125 0.40625 0 0.0993682 0.100107 1.13457 71.0905 +0.375 0.1875 -0.1875 0.375 0 0.100589 0.100425 1.24418 265.493 +0.40625 0.1875 -0.1875 0.40625 0 0.0982417 0.100075 1.26868 265.493 -0.375 0.15625 -0.15625 0.375 0 0.0999327 0.100447 1.17864 71.0905 -0.40625 0.15625 -0.15625 0.40625 0 0.0995704 0.0997099 1.19654 71.0905 +0.40625 0.15625 -0.15625 0.40625 0 0.0996106 0.0997082 1.19654 312.363 +0.4375 0.15625 -0.15625 0.4375 0 0.0994693 0.100212 1.21005 312.363 -0.40625 0.125 -0.125 0.40625 0 0.0993682 0.100107 1.13457 78.8586 -0.4375 0.125 -0.125 0.4375 0 0.0994322 0.100611 1.14385 78.8586 +0.40625 0.1875 -0.1875 0.40625 0 0.0982417 0.100075 1.26868 312.363 +0.4375 0.1875 -0.1875 0.4375 0 0.0984254 0.100063 1.28804 312.363 -0.40625 0.15625 -0.15625 0.40625 0 0.0995704 0.0997099 1.19654 78.8586 -0.4375 0.15625 -0.15625 0.4375 0 0.0994565 0.100213 1.21005 78.8586 +0.4375 0.125 -0.125 0.4375 0 0.0994372 0.100613 1.14385 102.665 +0.46875 0.125 -0.125 0.46875 0 0.0993125 0.0999655 1.14683 102.665 -0.375 0.15625 -0.15625 0.375 0 0.0999327 0.100447 1.17864 265.493 -0.40625 0.15625 -0.15625 0.40625 0 0.0995704 0.0997099 1.19654 265.493 +0.4375 0.15625 -0.15625 0.4375 0 0.0994693 0.100212 1.21005 102.665 +0.46875 0.15625 -0.15625 0.46875 0 0.0994622 0.0999899 1.21426 102.665 -0.375 0.1875 -0.1875 0.375 0 0.100589 0.100428 1.24418 265.493 -0.40625 0.1875 -0.1875 0.40625 0 0.0981222 0.100079 1.26868 265.493 +0.46875 0.125 -0.125 0.46875 0 0.0993125 0.0999655 1.14683 113.992 +0.5 0.125 -0.125 0.5 0 0.0992838 0.100105 1.14461 113.992 -0.40625 0.15625 -0.15625 0.40625 0 0.0995704 0.0997099 1.19654 312.363 -0.4375 0.15625 -0.15625 0.4375 0 0.0994565 0.100213 1.21005 312.363 +0.46875 0.15625 -0.15625 0.46875 0 0.0994622 0.0999899 1.21426 113.992 +0.5 0.15625 -0.15625 0.5 0 0.0994108 0.100051 1.21088 113.992 -0.40625 0.1875 -0.1875 0.40625 0 0.0981222 0.100079 1.26868 312.363 -0.4375 0.1875 -0.1875 0.4375 0 0.0983928 0.100065 1.28804 312.363 +0.4375 0.15625 -0.15625 0.4375 0 0.0994693 0.100212 1.21005 353.501 +0.46875 0.15625 -0.15625 0.46875 0 0.0994622 0.0999899 1.21426 353.501 -0.4375 0.125 -0.125 0.4375 0 0.0994322 0.100611 1.14385 102.665 -0.46875 0.125 -0.125 0.46875 0 0.0993108 0.0999646 1.14683 102.665 +0.4375 0.1875 -0.1875 0.4375 0 0.0984254 0.100063 1.28804 353.501 +0.46875 0.1875 -0.1875 0.46875 0 0.0982702 0.100004 1.29396 353.501 -0.4375 0.15625 -0.15625 0.4375 0 0.0994565 0.100213 1.21005 102.665 -0.46875 0.15625 -0.15625 0.46875 0 0.0994585 0.09999 1.21426 102.665 +0.46875 0.15625 -0.15625 0.46875 0 0.0994622 0.0999899 1.21426 381.478 +0.5 0.15625 -0.15625 0.5 0 0.0994108 0.100051 1.21088 381.478 -0.46875 0.125 -0.125 0.46875 0 0.0993108 0.0999646 1.14683 113.992 -0.5 0.125 -0.125 0.5 0 0.0992833 0.100104 1.14461 113.992 +0.46875 0.1875 -0.1875 0.46875 0 0.0982702 0.100004 1.29396 381.478 +0.5 0.1875 -0.1875 0.5 0 0.0983092 0.100014 1.28953 381.478 -0.46875 0.15625 -0.15625 0.46875 0 0.0994585 0.09999 1.21426 113.992 -0.5 0.15625 -0.15625 0.5 0 0.0994098 0.100051 1.21088 113.992 +0.375 0.1875 -0.1875 0.375 0 0.100589 0.100425 1.24418 374.444 +0.40625 0.1875 -0.1875 0.40625 0 0.0982417 0.100075 1.26868 374.444 -0.4375 0.15625 -0.15625 0.4375 0 0.0994565 0.100213 1.21005 353.501 -0.46875 0.15625 -0.15625 0.46875 0 0.0994585 0.09999 1.21426 353.501 +0.375 0.21875 -0.21875 0.375 0 0.0998429 0.0995912 1.32548 374.444 +0.40625 0.21875 -0.21875 0.40625 0 0.098632 0.099826 1.35903 374.444 -0.4375 0.1875 -0.1875 0.4375 0 0.0983928 0.100065 1.28804 353.501 -0.46875 0.1875 -0.1875 0.46875 0 0.0982618 0.100004 1.29396 353.501 +0.40625 0.1875 -0.1875 0.40625 0 0.0982417 0.100075 1.26868 545.815 +0.4375 0.1875 -0.1875 0.4375 0 0.0984254 0.100063 1.28804 545.815 -0.46875 0.15625 -0.15625 0.46875 0 0.0994585 0.09999 1.21426 381.478 -0.5 0.15625 -0.15625 0.5 0 0.0994098 0.100051 1.21088 381.478 +0.40625 0.21875 -0.21875 0.40625 0 0.098632 0.099826 1.35903 545.815 +0.4375 0.21875 -0.21875 0.4375 0 0.0989142 0.0999557 1.38364 545.815 -0.46875 0.1875 -0.1875 0.46875 0 0.0982618 0.100004 1.29396 381.478 -0.5 0.1875 -0.1875 0.5 0 0.0983071 0.100014 1.28953 381.478 +0.4375 0.1875 -0.1875 0.4375 0 0.0984254 0.100063 1.28804 597.428 +0.46875 0.1875 -0.1875 0.46875 0 0.0982702 0.100004 1.29396 597.428 -0.375 0.1875 -0.1875 0.375 0 0.100589 0.100428 1.24418 374.444 -0.40625 0.1875 -0.1875 0.40625 0 0.0981222 0.100079 1.26868 374.444 +0.4375 0.21875 -0.21875 0.4375 0 0.0989142 0.0999557 1.38364 597.428 +0.46875 0.21875 -0.21875 0.46875 0 0.0991035 0.0999836 1.39124 597.428 -0.375 0.21875 -0.21875 0.375 0 0.099852 0.0996006 1.3255 374.444 -0.40625 0.21875 -0.21875 0.40625 0 0.098266 0.0998355 1.35902 374.444 +0.46875 0.1875 -0.1875 0.46875 0 0.0982702 0.100004 1.29396 627.854 +0.5 0.1875 -0.1875 0.5 0 0.0983092 0.100014 1.28953 627.854 -0.40625 0.1875 -0.1875 0.40625 0 0.0981222 0.100079 1.26868 545.815 -0.4375 0.1875 -0.1875 0.4375 0 0.0983928 0.100065 1.28804 545.815 +0.46875 0.21875 -0.21875 0.46875 0 0.0991035 0.0999836 1.39124 627.854 +0.5 0.21875 -0.21875 0.5 0 0.0992955 0.0999983 1.38429 627.854 -0.40625 0.21875 -0.21875 0.40625 0 0.098266 0.0998355 1.35902 545.815 -0.4375 0.21875 -0.21875 0.4375 0 0.0988297 0.0999581 1.38363 545.815 +0.125 0.25 -0.25 0.125 0 0.100002 0.742775 1.04618 0.597747 +0.15625 0.25 -0.25 0.15625 0 0.0999999 0.266317 1.07147 0.597747 -0.375 0.21875 -0.21875 0.375 0 0.099852 0.0996006 1.3255 613.972 -0.40625 0.21875 -0.21875 0.40625 0 0.098266 0.0998355 1.35902 613.972 +0.125 0.28125 -0.28125 0.125 0 0.1 0.188268 1.05811 0.597747 +0.15625 0.28125 -0.28125 0.15625 0 0.0999965 0.103625 1.08796 0.597747 -0.375 0.25 -0.25 0.375 0 0.101953 0.100065 1.41803 613.972 -0.40625 0.25 -0.25 0.40625 0 0.100583 0.0999467 1.46136 613.972 +0.15625 0.25 -0.25 0.15625 0 0.0999999 0.266317 1.07147 2.22209 +0.1875 0.25 -0.25 0.1875 0 0.0999818 0.0825895 1.10243 2.22209 -0.4375 0.1875 -0.1875 0.4375 0 0.0983928 0.100065 1.28804 597.428 -0.46875 0.1875 -0.1875 0.46875 0 0.0982618 0.100004 1.29396 597.428 +0.15625 0.28125 -0.28125 0.15625 0 0.0999965 0.103625 1.08796 2.22209 +0.1875 0.28125 -0.28125 0.1875 0 0.100016 0.0970377 1.12712 2.22209 -0.4375 0.21875 -0.21875 0.4375 0 0.0988297 0.0999581 1.38363 597.428 -0.46875 0.21875 -0.21875 0.46875 0 0.0990848 0.0999841 1.39124 597.428 +0.125 0.28125 -0.28125 0.125 0 0.1 0.188268 1.05811 3.72242 +0.15625 0.28125 -0.28125 0.15625 0 0.0999965 0.103625 1.08796 3.72242 -0.46875 0.1875 -0.1875 0.46875 0 0.0982618 0.100004 1.29396 627.854 -0.5 0.1875 -0.1875 0.5 0 0.0983071 0.100014 1.28953 627.854 +0.125 0.3125 -0.3125 0.125 0 0.0999897 0.0756172 1.06914 3.72242 +0.15625 0.3125 -0.3125 0.15625 0 0.100022 0.109401 1.10456 3.72242 -0.46875 0.21875 -0.21875 0.46875 0 0.0990848 0.0999841 1.39124 627.854 -0.5 0.21875 -0.21875 0.5 0 0.0992915 0.0999985 1.38429 627.854 +0.15625 0.28125 -0.28125 0.15625 0 0.0999965 0.103625 1.08796 7.86082 +0.1875 0.28125 -0.28125 0.1875 0 0.100016 0.0970377 1.12712 7.86082 -0.125 0.25 -0.25 0.125 0 0.100001 0.745287 1.04613 0.597747 -0.15625 0.25 -0.25 0.15625 0 0.100002 0.258961 1.07141 0.597747 +0.15625 0.3125 -0.3125 0.15625 0 0.100022 0.109401 1.10456 7.86082 +0.1875 0.3125 -0.3125 0.1875 0 0.0998968 0.094197 1.15107 7.86082 -0.125 0.28125 -0.28125 0.125 0 0.100001 0.187944 1.05812 0.597747 -0.15625 0.28125 -0.28125 0.15625 0 0.0999968 0.102926 1.08795 0.597747 +0.1875 0.25 -0.25 0.1875 0 0.0999818 0.0825895 1.10243 6.76569 +0.21875 0.25 -0.25 0.21875 0 0.100157 0.0982873 1.14302 6.76569 -0.15625 0.25 -0.25 0.15625 0 0.100002 0.258961 1.07141 2.22209 -0.1875 0.25 -0.25 0.1875 0 0.0999859 0.0858224 1.10254 2.22209 +0.1875 0.28125 -0.28125 0.1875 0 0.100016 0.0970377 1.12712 6.76569 +0.21875 0.28125 -0.28125 0.21875 0 0.0999997 0.101791 1.17717 6.76569 -0.15625 0.28125 -0.28125 0.15625 0 0.0999968 0.102926 1.08795 2.22209 -0.1875 0.28125 -0.28125 0.1875 0 0.100016 0.0973215 1.12713 2.22209 +0.21875 0.25 -0.25 0.21875 0 0.100157 0.0982873 1.14302 73.1044 +0.25 0.25 -0.25 0.25 0 0.0999122 0.102162 1.19144 73.1044 -0.125 0.28125 -0.28125 0.125 0 0.100001 0.187944 1.05812 3.72242 -0.15625 0.28125 -0.28125 0.15625 0 0.0999968 0.102926 1.08795 3.72242 +0.21875 0.28125 -0.28125 0.21875 0 0.0999997 0.101791 1.17717 73.1044 +0.25 0.28125 -0.28125 0.25 0 0.100484 0.0984171 1.23871 73.1044 -0.125 0.3125 -0.3125 0.125 0 0.0999895 0.0759783 1.06914 3.72242 -0.15625 0.3125 -0.3125 0.15625 0 0.100022 0.109432 1.10456 3.72242 +0.1875 0.28125 -0.28125 0.1875 0 0.100016 0.0970377 1.12712 25.4669 +0.21875 0.28125 -0.28125 0.21875 0 0.0999997 0.101791 1.17717 25.4669 -0.15625 0.28125 -0.28125 0.15625 0 0.0999968 0.102926 1.08795 7.86082 -0.1875 0.28125 -0.28125 0.1875 0 0.100016 0.0973215 1.12713 7.86082 +0.1875 0.3125 -0.3125 0.1875 0 0.0998968 0.094197 1.15107 25.4669 +0.21875 0.3125 -0.3125 0.21875 0 0.100733 0.0989522 1.20994 25.4669 -0.15625 0.3125 -0.3125 0.15625 0 0.100022 0.109432 1.10456 7.86082 -0.1875 0.3125 -0.3125 0.1875 0 0.0998969 0.0942483 1.15107 7.86082 +0.21875 0.28125 -0.28125 0.21875 0 0.0999997 0.101791 1.17717 139.082 +0.25 0.28125 -0.28125 0.25 0 0.100484 0.0984171 1.23871 139.082 -0.1875 0.25 -0.25 0.1875 0 0.0999859 0.0858224 1.10254 6.76569 -0.21875 0.25 -0.25 0.21875 0 0.100158 0.0990889 1.14305 6.76569 +0.21875 0.3125 -0.3125 0.21875 0 0.100733 0.0989522 1.20994 139.082 +0.25 0.3125 -0.3125 0.25 0 0.0993622 0.0986164 1.28018 139.082 -0.1875 0.28125 -0.28125 0.1875 0 0.100016 0.0973215 1.12713 6.76569 -0.21875 0.28125 -0.28125 0.21875 0 0.0999997 0.101841 1.17717 6.76569 +0.125 0.3125 -0.3125 0.125 0 0.0999897 0.0756172 1.06914 10.2738 +0.15625 0.3125 -0.3125 0.15625 0 0.100022 0.109401 1.10456 10.2738 -0.21875 0.25 -0.25 0.21875 0 0.100158 0.0990889 1.14305 73.1044 -0.25 0.25 -0.25 0.25 0 0.0999125 0.102361 1.19145 73.1044 +0.125 0.34375 -0.34375 0.125 0 0.100038 0.0942402 1.07912 10.2738 +0.15625 0.34375 -0.34375 0.15625 0 0.0998666 0.100131 1.11961 10.2738 -0.21875 0.28125 -0.28125 0.21875 0 0.0999997 0.101841 1.17717 73.1044 -0.25 0.28125 -0.28125 0.25 0 0.100484 0.0984233 1.23871 73.1044 +0.15625 0.3125 -0.3125 0.15625 0 0.100022 0.109401 1.10456 50.4508 +0.1875 0.3125 -0.3125 0.1875 0 0.0998968 0.094197 1.15107 50.4508 -0.1875 0.28125 -0.28125 0.1875 0 0.100016 0.0973215 1.12713 25.4669 -0.21875 0.28125 -0.28125 0.21875 0 0.0999997 0.101841 1.17717 25.4669 +0.15625 0.34375 -0.34375 0.15625 0 0.0998666 0.100131 1.11961 50.4508 +0.1875 0.34375 -0.34375 0.1875 0 0.100469 0.0976932 1.17299 50.4508 -0.1875 0.3125 -0.3125 0.1875 0 0.0998969 0.0942483 1.15107 25.4669 -0.21875 0.3125 -0.3125 0.21875 0 0.100733 0.0989607 1.20994 25.4669 +0.125 0.34375 -0.34375 0.125 0 0.100038 0.0942402 1.07912 19.1819 +0.15625 0.34375 -0.34375 0.15625 0 0.0998666 0.100131 1.11961 19.1819 -0.21875 0.28125 -0.28125 0.21875 0 0.0999997 0.101841 1.17717 139.082 -0.25 0.28125 -0.28125 0.25 0 0.100484 0.0984233 1.23871 139.082 +0.125 0.375 -0.375 0.125 0 0.10005 0.0822996 1.08696 19.1819 +0.15625 0.375 -0.375 0.15625 0 0.0997261 0.0974175 1.13158 19.1819 -0.21875 0.3125 -0.3125 0.21875 0 0.100733 0.0989607 1.20994 139.082 -0.25 0.3125 -0.3125 0.25 0 0.0993622 0.0986174 1.28018 139.082 +0.15625 0.34375 -0.34375 0.15625 0 0.0998666 0.100131 1.11961 71.3188 +0.1875 0.34375 -0.34375 0.1875 0 0.100469 0.0976932 1.17299 71.3188 -0.125 0.3125 -0.3125 0.125 0 0.0999895 0.0759783 1.06914 10.2738 -0.15625 0.3125 -0.3125 0.15625 0 0.100022 0.109432 1.10456 10.2738 +0.15625 0.375 -0.375 0.15625 0 0.0997261 0.0974175 1.13158 71.3188 +0.1875 0.375 -0.375 0.1875 0 0.100712 0.0948831 1.18992 71.3188 -0.125 0.34375 -0.34375 0.125 0 0.100038 0.0942022 1.07912 10.2738 -0.15625 0.34375 -0.34375 0.15625 0 0.0998666 0.100112 1.11961 10.2738 +0.1875 0.3125 -0.3125 0.1875 0 0.0998968 0.094197 1.15107 52.9251 +0.21875 0.3125 -0.3125 0.21875 0 0.100733 0.0989522 1.20994 52.9251 -0.15625 0.3125 -0.3125 0.15625 0 0.100022 0.109432 1.10456 50.4508 -0.1875 0.3125 -0.3125 0.1875 0 0.0998969 0.0942483 1.15107 50.4508 +0.1875 0.34375 -0.34375 0.1875 0 0.100469 0.0976932 1.17299 52.9251 +0.21875 0.34375 -0.34375 0.21875 0 0.0956329 0.0998037 1.2391 52.9251 -0.15625 0.34375 -0.34375 0.15625 0 0.0998666 0.100112 1.11961 50.4508 -0.1875 0.34375 -0.34375 0.1875 0 0.100469 0.0976918 1.17299 50.4508 +0.21875 0.3125 -0.3125 0.21875 0 0.100733 0.0989522 1.20994 659.248 +0.25 0.3125 -0.3125 0.25 0 0.0993622 0.0986164 1.28018 659.248 -0.125 0.34375 -0.34375 0.125 0 0.100038 0.0942022 1.07912 19.1819 -0.15625 0.34375 -0.34375 0.15625 0 0.0998666 0.100112 1.11961 19.1819 +0.21875 0.34375 -0.34375 0.21875 0 0.0956329 0.0998037 1.2391 659.248 +0.25 0.34375 -0.34375 0.25 0 0.0918069 0.0992821 1.32055 659.248 -0.125 0.375 -0.375 0.125 0 0.10005 0.0823468 1.08696 19.1819 -0.15625 0.375 -0.375 0.15625 0 0.0997261 0.0974305 1.13158 19.1819 +0.1875 0.34375 -0.34375 0.1875 0 0.100469 0.0976932 1.17299 99.349 +0.21875 0.34375 -0.34375 0.21875 0 0.0956329 0.0998037 1.2391 99.349 -0.15625 0.34375 -0.34375 0.15625 0 0.0998666 0.100112 1.11961 71.3188 -0.1875 0.34375 -0.34375 0.1875 0 0.100469 0.0976918 1.17299 71.3188 +0.1875 0.375 -0.375 0.1875 0 0.100712 0.0948831 1.18992 99.349 +0.21875 0.375 -0.375 0.21875 0 0.0904056 0.0992099 1.26256 99.349 -0.15625 0.375 -0.375 0.15625 0 0.0997261 0.0974305 1.13158 71.3188 -0.1875 0.375 -0.375 0.1875 0 0.100712 0.0948873 1.18992 71.3188 +0.21875 0.34375 -0.34375 0.21875 0 0.0956329 0.0998037 1.2391 2393.63 +0.25 0.34375 -0.34375 0.25 0 0.0918069 0.0992821 1.32055 2393.63 -0.1875 0.3125 -0.3125 0.1875 0 0.0998969 0.0942483 1.15107 52.9251 -0.21875 0.3125 -0.3125 0.21875 0 0.100733 0.0989607 1.20994 52.9251 +0.21875 0.375 -0.375 0.21875 0 0.0904056 0.0992099 1.26256 2393.63 +0.25 0.375 -0.375 0.25 0 0.106569 0.0987756 1.35295 2393.63 -0.1875 0.34375 -0.34375 0.1875 0 0.100469 0.0976918 1.17299 52.9251 -0.21875 0.34375 -0.34375 0.21875 0 0.0956329 0.0998027 1.2391 52.9251 +0.125 0.375 -0.375 0.125 0 0.10005 0.0822996 1.08696 18.8605 +0.15625 0.375 -0.375 0.15625 0 0.0997261 0.0974175 1.13158 18.8605 -0.21875 0.3125 -0.3125 0.21875 0 0.100733 0.0989607 1.20994 659.248 -0.25 0.3125 -0.3125 0.25 0 0.0993622 0.0986174 1.28018 659.248 +0.125 0.40625 -0.40625 0.125 0 0.0999046 0.0985969 1.09229 18.8605 +0.15625 0.40625 -0.40625 0.15625 0 0.101038 0.09961 1.13938 18.8605 -0.21875 0.34375 -0.34375 0.21875 0 0.0956329 0.0998027 1.2391 659.248 -0.25 0.34375 -0.34375 0.25 0 0.0918069 0.0992817 1.32055 659.248 +0.15625 0.375 -0.375 0.15625 0 0.0997261 0.0974175 1.13158 366.454 +0.1875 0.375 -0.375 0.1875 0 0.100712 0.0948831 1.18992 366.454 -0.1875 0.34375 -0.34375 0.1875 0 0.100469 0.0976918 1.17299 99.349 -0.21875 0.34375 -0.34375 0.21875 0 0.0956329 0.0998027 1.2391 99.349 +0.15625 0.40625 -0.40625 0.15625 0 0.101038 0.09961 1.13938 366.454 +0.1875 0.40625 -0.40625 0.1875 0 0.0975951 0.0993454 1.20105 366.454 -0.1875 0.375 -0.375 0.1875 0 0.100712 0.0948873 1.18992 99.349 -0.21875 0.375 -0.375 0.21875 0 0.0904056 0.099211 1.26256 99.349 +0.125 0.40625 -0.40625 0.125 0 0.0999046 0.0985969 1.09229 47.0863 +0.15625 0.40625 -0.40625 0.15625 0 0.101038 0.09961 1.13938 47.0863 -0.21875 0.34375 -0.34375 0.21875 0 0.0956329 0.0998027 1.2391 2393.63 -0.25 0.34375 -0.34375 0.25 0 0.0918069 0.0992817 1.32055 2393.63 +0.125 0.4375 -0.4375 0.125 0 0.100052 0.0991 1.09357 47.0863 +0.15625 0.4375 -0.4375 0.15625 0 0.102166 0.0997817 1.14193 47.0863 -0.21875 0.375 -0.375 0.21875 0 0.0904056 0.099211 1.26256 2393.63 -0.25 0.375 -0.375 0.25 0 0.106569 0.0987759 1.35295 2393.63 +0.15625 0.40625 -0.40625 0.15625 0 0.101038 0.09961 1.13938 470.03 +0.1875 0.40625 -0.40625 0.1875 0 0.0975951 0.0993454 1.20105 470.03 -0.125 0.375 -0.375 0.125 0 0.10005 0.0823468 1.08696 18.8605 -0.15625 0.375 -0.375 0.15625 0 0.0997261 0.0974305 1.13158 18.8605 +0.15625 0.4375 -0.4375 0.15625 0 0.102166 0.0997817 1.14193 470.03 +0.1875 0.4375 -0.4375 0.1875 0 0.100825 0.0998298 1.20425 470.03 -0.125 0.40625 -0.40625 0.125 0 0.0999046 0.0985912 1.09229 18.8605 -0.15625 0.40625 -0.40625 0.15625 0 0.101038 0.0996079 1.13938 18.8605 +0.1875 0.375 -0.375 0.1875 0 0.100712 0.0948831 1.18992 800.726 +0.21875 0.375 -0.375 0.21875 0 0.0904056 0.0992099 1.26256 800.726 -0.15625 0.375 -0.375 0.15625 0 0.0997261 0.0974305 1.13158 366.454 -0.1875 0.375 -0.375 0.1875 0 0.100712 0.0948873 1.18992 366.454 +0.1875 0.40625 -0.40625 0.1875 0 0.0975951 0.0993454 1.20105 800.726 +0.21875 0.40625 -0.40625 0.21875 0 0.136527 0.0998272 1.27751 800.726 -0.15625 0.40625 -0.40625 0.15625 0 0.101038 0.0996079 1.13938 366.454 -0.1875 0.40625 -0.40625 0.1875 0 0.0975951 0.0993448 1.20105 366.454 +0.21875 0.375 -0.375 0.21875 0 0.0904056 0.0992099 1.26256 4502.2 +0.25 0.375 -0.375 0.25 0 0.106569 0.0987756 1.35295 4502.2 -0.125 0.40625 -0.40625 0.125 0 0.0999046 0.0985912 1.09229 47.0863 -0.15625 0.40625 -0.40625 0.15625 0 0.101038 0.0996079 1.13938 47.0863 +0.21875 0.40625 -0.40625 0.21875 0 0.136527 0.0998272 1.27751 4502.2 +0.25 0.40625 -0.40625 0.25 0 0.284767 0.0997589 1.37334 4502.2 -0.125 0.4375 -0.4375 0.125 0 0.100052 0.099107 1.09357 47.0863 -0.15625 0.4375 -0.4375 0.15625 0 0.102166 0.0997841 1.14193 47.0863 +0.1875 0.40625 -0.40625 0.1875 0 0.0975951 0.0993454 1.20105 1299.11 +0.21875 0.40625 -0.40625 0.21875 0 0.136527 0.0998272 1.27751 1299.11 -0.15625 0.40625 -0.40625 0.15625 0 0.101038 0.0996079 1.13938 470.03 -0.1875 0.40625 -0.40625 0.1875 0 0.0975951 0.0993448 1.20105 470.03 +0.1875 0.4375 -0.4375 0.1875 0 0.100825 0.0998298 1.20425 1299.11 +0.21875 0.4375 -0.4375 0.21875 0 0.197146 0.0999514 1.28278 1299.11 -0.15625 0.4375 -0.4375 0.15625 0 0.102166 0.0997841 1.14193 470.03 -0.1875 0.4375 -0.4375 0.1875 0 0.100825 0.0998306 1.20425 470.03 +0.21875 0.40625 -0.40625 0.21875 0 0.136527 0.0998272 1.27751 1643.15 +0.25 0.40625 -0.40625 0.25 0 0.284767 0.0997589 1.37334 1643.15 -0.1875 0.375 -0.375 0.1875 0 0.100712 0.0948873 1.18992 800.726 -0.21875 0.375 -0.375 0.21875 0 0.0904056 0.099211 1.26256 800.726 +0.21875 0.4375 -0.4375 0.21875 0 0.197146 0.0999514 1.28278 1643.15 +0.25 0.4375 -0.4375 0.25 0 0.461683 0.0999863 1.38041 1643.15 -0.1875 0.40625 -0.40625 0.1875 0 0.0975951 0.0993448 1.20105 800.726 -0.21875 0.40625 -0.40625 0.21875 0 0.136527 0.099827 1.27751 800.726 +0.125 0.4375 -0.4375 0.125 0 0.100052 0.0991 1.09357 64.6331 +0.15625 0.4375 -0.4375 0.15625 0 0.102166 0.0997817 1.14193 64.6331 -0.21875 0.375 -0.375 0.21875 0 0.0904056 0.099211 1.26256 4502.2 -0.25 0.375 -0.375 0.25 0 0.106569 0.0987759 1.35295 4502.2 +0.125 0.46875 -0.46875 0.125 0 0.100154 0.0998215 1.09239 64.6331 +0.15625 0.46875 -0.46875 0.15625 0 0.10249 0.0998867 1.13922 64.6331 -0.21875 0.40625 -0.40625 0.21875 0 0.136527 0.099827 1.27751 4502.2 -0.25 0.40625 -0.40625 0.25 0 0.284767 0.0997588 1.37334 4502.2 +0.15625 0.4375 -0.4375 0.15625 0 0.102166 0.0997817 1.14193 366.913 +0.1875 0.4375 -0.4375 0.1875 0 0.100825 0.0998298 1.20425 366.913 -0.1875 0.40625 -0.40625 0.1875 0 0.0975951 0.0993448 1.20105 1299.11 -0.21875 0.40625 -0.40625 0.21875 0 0.136527 0.099827 1.27751 1299.11 +0.15625 0.46875 -0.46875 0.15625 0 0.10249 0.0998867 1.13922 366.913 +0.1875 0.46875 -0.46875 0.1875 0 0.108539 0.09994 1.20045 366.913 -0.1875 0.4375 -0.4375 0.1875 0 0.100825 0.0998306 1.20425 1299.11 -0.21875 0.4375 -0.4375 0.21875 0 0.197146 0.0999516 1.28278 1299.11 +0.125 0.46875 -0.46875 0.125 0 0.100154 0.0998215 1.09239 56.9681 +0.15625 0.46875 -0.46875 0.15625 0 0.10249 0.0998867 1.13922 56.9681 -0.21875 0.40625 -0.40625 0.21875 0 0.136527 0.099827 1.27751 1643.15 -0.25 0.40625 -0.40625 0.25 0 0.284767 0.0997588 1.37334 1643.15 +0.125 0.5 -0.5 0.125 0 0.100415 0.100118 1.08562 56.9681 +0.15625 0.5 -0.5 0.15625 0 0.103337 0.100107 1.13164 56.9681 -0.21875 0.4375 -0.4375 0.21875 0 0.197146 0.0999516 1.28278 1643.15 -0.25 0.4375 -0.4375 0.25 0 0.461683 0.0999864 1.38041 1643.15 +0.15625 0.46875 -0.46875 0.15625 0 0.10249 0.0998867 1.13922 94.5255 +0.1875 0.46875 -0.46875 0.1875 0 0.108539 0.09994 1.20045 94.5255 -0.125 0.4375 -0.4375 0.125 0 0.100052 0.099107 1.09357 64.6331 -0.15625 0.4375 -0.4375 0.15625 0 0.102166 0.0997841 1.14193 64.6331 +0.15625 0.5 -0.5 0.15625 0 0.103337 0.100107 1.13164 94.5255 +0.1875 0.5 -0.5 0.1875 0 0.114075 0.0999783 1.1881 94.5255 -0.125 0.46875 -0.46875 0.125 0 0.100154 0.0998207 1.09239 64.6331 -0.15625 0.46875 -0.46875 0.15625 0 0.10249 0.0998864 1.13922 64.6331 +0.1875 0.4375 -0.4375 0.1875 0 0.100825 0.0998298 1.20425 1288.55 +0.21875 0.4375 -0.4375 0.21875 0 0.197146 0.0999514 1.28278 1288.55 -0.15625 0.4375 -0.4375 0.15625 0 0.102166 0.0997841 1.14193 366.913 -0.1875 0.4375 -0.4375 0.1875 0 0.100825 0.0998306 1.20425 366.913 - -0.15625 0.46875 -0.46875 0.15625 0 0.10249 0.0998864 1.13922 366.913 -0.1875 0.46875 -0.46875 0.1875 0 0.108539 0.0999399 1.20045 366.913 - - -0.125 0.46875 -0.46875 0.125 0 0.100154 0.0998207 1.09239 56.9681 -0.15625 0.46875 -0.46875 0.15625 0 0.10249 0.0998864 1.13922 56.9681 - -0.125 0.5 -0.5 0.125 0 0.100415 0.100119 1.08562 56.9681 -0.15625 0.5 -0.5 0.15625 0 0.103337 0.100108 1.13164 56.9681 - - -0.15625 0.46875 -0.46875 0.15625 0 0.10249 0.0998864 1.13922 94.5255 -0.1875 0.46875 -0.46875 0.1875 0 0.108539 0.0999399 1.20045 94.5255 - -0.15625 0.5 -0.5 0.15625 0 0.103337 0.100108 1.13164 94.5255 -0.1875 0.5 -0.5 0.1875 0 0.114075 0.0999784 1.1881 94.5255 - - -0.1875 0.4375 -0.4375 0.1875 0 0.100825 0.0998306 1.20425 1288.55 -0.21875 0.4375 -0.4375 0.21875 0 0.197146 0.0999516 1.28278 1288.55 - -0.1875 0.46875 -0.46875 0.1875 0 0.108539 0.0999399 1.20045 1288.55 +0.1875 0.46875 -0.46875 0.1875 0 0.108539 0.09994 1.20045 1288.55 0.21875 0.46875 -0.46875 0.21875 0 0.219834 0.0999709 1.27852 1288.55 -0.21875 0.4375 -0.4375 0.21875 0 0.197146 0.0999516 1.28278 479.208 -0.25 0.4375 -0.4375 0.25 0 0.461683 0.0999864 1.38041 479.208 +0.21875 0.4375 -0.4375 0.21875 0 0.197146 0.0999514 1.28278 479.208 +0.25 0.4375 -0.4375 0.25 0 0.461683 0.0999863 1.38041 479.208 0.21875 0.46875 -0.46875 0.21875 0 0.219834 0.0999709 1.27852 479.208 0.25 0.46875 -0.46875 0.25 0 0.457393 0.0999791 1.37277 479.208 -0.1875 0.46875 -0.46875 0.1875 0 0.108539 0.0999399 1.20045 1038.07 +0.1875 0.46875 -0.46875 0.1875 0 0.108539 0.09994 1.20045 1038.07 0.21875 0.46875 -0.46875 0.21875 0 0.219834 0.0999709 1.27852 1038.07 -0.1875 0.5 -0.5 0.1875 0 0.114075 0.0999784 1.1881 1038.07 -0.21875 0.5 -0.5 0.21875 0 0.232387 0.100014 1.26269 1038.07 +0.1875 0.5 -0.5 0.1875 0 0.114075 0.0999783 1.1881 1038.07 +0.21875 0.5 -0.5 0.21875 0 0.232387 0.100013 1.26269 1038.07 0.21875 0.46875 -0.46875 0.21875 0 0.219834 0.0999709 1.27852 502.168 0.25 0.46875 -0.46875 0.25 0 0.457393 0.0999791 1.37277 502.168 -0.21875 0.5 -0.5 0.21875 0 0.232387 0.100014 1.26269 502.168 +0.21875 0.5 -0.5 0.21875 0 0.232387 0.100013 1.26269 502.168 0.25 0.5 -0.5 0.25 0 0.462289 0.0999841 1.35065 502.168 -0.25 0.25 -0.25 0.25 0 0.0999125 0.102361 1.19145 93.4668 -0.28125 0.25 -0.25 0.28125 0 0.101049 0.0994343 1.24616 93.4668 +0.25 0.25 -0.25 0.25 0 0.0999122 0.102162 1.19144 93.4668 +0.28125 0.25 -0.25 0.28125 0 0.101049 0.0993885 1.24616 93.4668 -0.25 0.28125 -0.28125 0.25 0 0.100484 0.0984233 1.23871 93.4668 -0.28125 0.28125 -0.28125 0.28125 0 0.0975919 0.099945 1.30479 93.4668 +0.25 0.28125 -0.28125 0.25 0 0.100484 0.0984171 1.23871 93.4668 +0.28125 0.28125 -0.28125 0.28125 0 0.0975919 0.0999454 1.30479 93.4668 -0.28125 0.25 -0.25 0.28125 0 0.101049 0.0994343 1.24616 1204.58 -0.3125 0.25 -0.25 0.3125 0 0.105394 0.100771 1.30532 1204.58 +0.28125 0.25 -0.25 0.28125 0 0.101049 0.0993885 1.24616 1204.58 +0.3125 0.25 -0.25 0.3125 0 0.105394 0.100762 1.30532 1204.58 -0.28125 0.28125 -0.28125 0.28125 0 0.0975919 0.099945 1.30479 1204.58 -0.3125 0.28125 -0.28125 0.3125 0 0.08409 0.099566 1.37686 1204.58 +0.28125 0.28125 -0.28125 0.28125 0 0.0975919 0.0999454 1.30479 1204.58 +0.3125 0.28125 -0.28125 0.3125 0 0.0840902 0.0995666 1.37686 1204.58 -0.25 0.28125 -0.28125 0.25 0 0.100484 0.0984233 1.23871 457.73 -0.28125 0.28125 -0.28125 0.28125 0 0.0975919 0.099945 1.30479 457.73 +0.25 0.28125 -0.28125 0.25 0 0.100484 0.0984171 1.23871 457.73 +0.28125 0.28125 -0.28125 0.28125 0 0.0975919 0.0999454 1.30479 457.73 -0.25 0.3125 -0.3125 0.25 0 0.0993622 0.0986174 1.28018 457.73 +0.25 0.3125 -0.3125 0.25 0 0.0993622 0.0986164 1.28018 457.73 0.28125 0.3125 -0.3125 0.28125 0 0.108752 0.0998542 1.35917 457.73 -0.28125 0.28125 -0.28125 0.28125 0 0.0975919 0.099945 1.30479 1775.5 -0.3125 0.28125 -0.28125 0.3125 0 0.08409 0.099566 1.37686 1775.5 +0.28125 0.28125 -0.28125 0.28125 0 0.0975919 0.0999454 1.30479 1775.5 +0.3125 0.28125 -0.28125 0.3125 0 0.0840902 0.0995666 1.37686 1775.5 0.28125 0.3125 -0.3125 0.28125 0 0.108752 0.0998542 1.35917 1775.5 -0.3125 0.3125 -0.3125 0.3125 0 0.157764 0.0995807 1.44813 1775.5 +0.3125 0.3125 -0.3125 0.3125 0 0.157764 0.0995808 1.44813 1775.5 -0.3125 0.25 -0.25 0.3125 0 0.105394 0.100771 1.30532 1844.92 -0.34375 0.25 -0.25 0.34375 0 0.103571 0.0999891 1.36211 1844.92 +0.3125 0.25 -0.25 0.3125 0 0.105394 0.100762 1.30532 1844.92 +0.34375 0.25 -0.25 0.34375 0 0.10358 0.099989 1.3621 1844.92 -0.3125 0.28125 -0.28125 0.3125 0 0.08409 0.099566 1.37686 1844.92 -0.34375 0.28125 -0.28125 0.34375 0 0.0757971 0.0998589 1.44892 1844.92 +0.3125 0.28125 -0.28125 0.3125 0 0.0840902 0.0995666 1.37686 1844.92 +0.34375 0.28125 -0.28125 0.34375 0 0.075798 0.0998593 1.44892 1844.92 -0.25 0.3125 -0.3125 0.25 0 0.0993622 0.0986174 1.28018 1083.1 +0.25 0.3125 -0.3125 0.25 0 0.0993622 0.0986164 1.28018 1083.1 0.28125 0.3125 -0.3125 0.28125 0 0.108752 0.0998542 1.35917 1083.1 -0.25 0.34375 -0.34375 0.25 0 0.0918069 0.0992817 1.32055 1083.1 -0.28125 0.34375 -0.34375 0.28125 0 0.224569 0.0993848 1.41182 1083.1 +0.25 0.34375 -0.34375 0.25 0 0.0918069 0.0992821 1.32055 1083.1 +0.28125 0.34375 -0.34375 0.28125 0 0.224569 0.0993849 1.41182 1083.1 -0.25 0.34375 -0.34375 0.25 0 0.0918069 0.0992817 1.32055 1967.7 -0.28125 0.34375 -0.34375 0.28125 0 0.224569 0.0993848 1.41182 1967.7 +0.25 0.34375 -0.34375 0.25 0 0.0918069 0.0992821 1.32055 1967.7 +0.28125 0.34375 -0.34375 0.28125 0 0.224569 0.0993849 1.41182 1967.7 -0.25 0.375 -0.375 0.25 0 0.106569 0.0987759 1.35295 1967.7 -0.28125 0.375 -0.375 0.28125 0 0.370069 0.0989537 1.4532 1967.7 +0.25 0.375 -0.375 0.25 0 0.106569 0.0987756 1.35295 1967.7 +0.28125 0.375 -0.375 0.28125 0 0.370069 0.0989536 1.4532 1967.7 0.375 0.34375 -0.34375 0.375 0 0.499926 0.0999648 1.70378 318.848 @@ -1517,21 +1468,21 @@ 0.5 0.375 -0.375 0.5 0 0.502034 0.0999963 1.90597 181.502 -0.25 0.375 -0.375 0.25 0 0.106569 0.0987759 1.35295 4664.67 -0.28125 0.375 -0.375 0.28125 0 0.370069 0.0989537 1.4532 4664.67 +0.25 0.375 -0.375 0.25 0 0.106569 0.0987756 1.35295 4664.67 +0.28125 0.375 -0.375 0.28125 0 0.370069 0.0989536 1.4532 4664.67 -0.25 0.40625 -0.40625 0.25 0 0.284767 0.0997588 1.37334 4664.67 +0.25 0.40625 -0.40625 0.25 0 0.284767 0.0997589 1.37334 4664.67 0.28125 0.40625 -0.40625 0.28125 0 0.452366 0.0997222 1.47951 4664.67 -0.25 0.40625 -0.40625 0.25 0 0.284767 0.0997588 1.37334 4912.86 +0.25 0.40625 -0.40625 0.25 0 0.284767 0.0997589 1.37334 4912.86 0.28125 0.40625 -0.40625 0.28125 0 0.452366 0.0997222 1.47951 4912.86 -0.25 0.4375 -0.4375 0.25 0 0.461683 0.0999864 1.38041 4912.86 +0.25 0.4375 -0.4375 0.25 0 0.461683 0.0999863 1.38041 4912.86 0.28125 0.4375 -0.4375 0.28125 0 0.532004 0.100015 1.48977 4912.86 -0.25 0.4375 -0.4375 0.25 0 0.461683 0.0999864 1.38041 3849.99 +0.25 0.4375 -0.4375 0.25 0 0.461683 0.0999863 1.38041 3849.99 0.28125 0.4375 -0.4375 0.28125 0 0.532004 0.100015 1.48977 3849.99 0.25 0.46875 -0.46875 0.25 0 0.457393 0.0999791 1.37277 3849.99 @@ -1657,42 +1608,42 @@ 0.5 0.5 -0.5 0.5 0 0.498913 0.0999998 1.89421 167.149 -0.5 0.0625 -0.0625 0.5 0 0.0997804 0.100301 1.06236 39.403 -0.53125 0.0625 -0.0625 0.53125 0 0.0997778 0.0999234 1.05928 39.403 +0.5 0.0625 -0.0625 0.5 0 0.0997806 0.100315 1.06236 39.403 +0.53125 0.0625 -0.0625 0.53125 0 0.0997778 0.0999213 1.05928 39.403 -0.5 0.09375 -0.09375 0.5 0 0.0997634 0.100491 1.09737 39.403 -0.53125 0.09375 -0.09375 0.53125 0 0.0997894 0.0999729 1.09227 39.403 +0.5 0.09375 -0.09375 0.5 0 0.0997636 0.100492 1.09737 39.403 +0.53125 0.09375 -0.09375 0.53125 0 0.0997895 0.0999729 1.09227 39.403 -0.53125 0.0625 -0.0625 0.53125 0 0.0997778 0.0999234 1.05928 45.2439 -0.5625 0.0625 -0.0625 0.5625 0 0.0996904 0.100077 1.05391 45.2439 +0.53125 0.0625 -0.0625 0.53125 0 0.0997778 0.0999213 1.05928 45.2439 +0.5625 0.0625 -0.0625 0.5625 0 0.0996905 0.100079 1.05391 45.2439 -0.53125 0.09375 -0.09375 0.53125 0 0.0997894 0.0999729 1.09227 45.2439 +0.53125 0.09375 -0.09375 0.53125 0 0.0997895 0.0999729 1.09227 45.2439 0.5625 0.09375 -0.09375 0.5625 0 0.100046 0.100071 1.08423 45.2439 -0.5 0.09375 -0.09375 0.5 0 0.0997634 0.100491 1.09737 120.615 -0.53125 0.09375 -0.09375 0.53125 0 0.0997894 0.0999729 1.09227 120.615 +0.5 0.09375 -0.09375 0.5 0 0.0997636 0.100492 1.09737 120.615 +0.53125 0.09375 -0.09375 0.53125 0 0.0997895 0.0999729 1.09227 120.615 -0.5 0.125 -0.125 0.5 0 0.0992833 0.100104 1.14461 120.615 -0.53125 0.125 -0.125 0.53125 0 0.0993019 0.099995 1.13694 120.615 +0.5 0.125 -0.125 0.5 0 0.0992838 0.100105 1.14461 120.615 +0.53125 0.125 -0.125 0.53125 0 0.099302 0.0999951 1.13694 120.615 -0.53125 0.09375 -0.09375 0.53125 0 0.0997894 0.0999729 1.09227 137.207 +0.53125 0.09375 -0.09375 0.53125 0 0.0997895 0.0999729 1.09227 137.207 0.5625 0.09375 -0.09375 0.5625 0 0.100046 0.100071 1.08423 137.207 -0.53125 0.125 -0.125 0.53125 0 0.0993019 0.099995 1.13694 137.207 +0.53125 0.125 -0.125 0.53125 0 0.099302 0.0999951 1.13694 137.207 0.5625 0.125 -0.125 0.5625 0 0.0991816 0.100018 1.12399 137.207 -0.5625 0.0625 -0.0625 0.5625 0 0.0996904 0.100077 1.05391 46.1231 -0.59375 0.0625 -0.0625 0.59375 0 0.0998792 0.0999865 1.04749 46.1231 +0.5625 0.0625 -0.0625 0.5625 0 0.0996905 0.100079 1.05391 46.1231 +0.59375 0.0625 -0.0625 0.59375 0 0.0998792 0.0999862 1.04749 46.1231 0.5625 0.09375 -0.09375 0.5625 0 0.100046 0.100071 1.08423 46.1231 0.59375 0.09375 -0.09375 0.59375 0 0.100042 0.0999914 1.07405 46.1231 -0.59375 0.0625 -0.0625 0.59375 0 0.0998792 0.0999865 1.04749 62.48 +0.59375 0.0625 -0.0625 0.59375 0 0.0998792 0.0999862 1.04749 62.48 0.625 0.0625 -0.0625 0.625 0 0.100378 0.100014 1.04028 62.48 0.59375 0.09375 -0.09375 0.59375 0 0.100042 0.0999914 1.07405 62.48 @@ -1703,24 +1654,24 @@ 0.59375 0.09375 -0.09375 0.59375 0 0.100042 0.0999914 1.07405 120.301 0.5625 0.125 -0.125 0.5625 0 0.0991816 0.100018 1.12399 120.301 -0.59375 0.125 -0.125 0.59375 0 0.0997314 0.0999973 1.10892 120.301 +0.59375 0.125 -0.125 0.59375 0 0.0997314 0.0999974 1.10892 120.301 0.59375 0.09375 -0.09375 0.59375 0 0.100042 0.0999914 1.07405 100.365 0.625 0.09375 -0.09375 0.625 0 0.0998394 0.100013 1.06216 100.365 -0.59375 0.125 -0.125 0.59375 0 0.0997314 0.0999973 1.10892 100.365 +0.59375 0.125 -0.125 0.59375 0 0.0997314 0.0999974 1.10892 100.365 0.625 0.125 -0.125 0.625 0 0.100625 0.100005 1.09141 100.365 0.625 0.0625 -0.0625 0.625 0 0.100378 0.100014 1.04028 75.4524 -0.65625 0.0625 -0.0625 0.65625 0 0.10022 0.0999979 1.03316 75.4524 +0.65625 0.0625 -0.0625 0.65625 0 0.10022 0.0999978 1.03316 75.4524 0.625 0.09375 -0.09375 0.625 0 0.0998394 0.100013 1.06216 75.4524 0.65625 0.09375 -0.09375 0.65625 0 0.0999212 0.0999982 1.05057 75.4524 -0.65625 0.0625 -0.0625 0.65625 0 0.10022 0.0999979 1.03316 50.1335 +0.65625 0.0625 -0.0625 0.65625 0 0.10022 0.0999978 1.03316 50.1335 0.6875 0.0625 -0.0625 0.6875 0 0.0998801 0.100002 1.02585 50.1335 0.65625 0.09375 -0.09375 0.65625 0 0.0999212 0.0999982 1.05057 50.1335 @@ -1741,98 +1692,98 @@ 0.6875 0.125 -0.125 0.6875 0 0.0998489 0.100001 1.05784 82.8797 -0.5 0.125 -0.125 0.5 0 0.0992833 0.100104 1.14461 119.279 -0.53125 0.125 -0.125 0.53125 0 0.0993019 0.099995 1.13694 119.279 +0.5 0.125 -0.125 0.5 0 0.0992838 0.100105 1.14461 119.279 +0.53125 0.125 -0.125 0.53125 0 0.099302 0.0999951 1.13694 119.279 -0.5 0.15625 -0.15625 0.5 0 0.0994098 0.100051 1.21088 119.279 -0.53125 0.15625 -0.15625 0.53125 0 0.0994654 0.1 1.19952 119.279 +0.5 0.15625 -0.15625 0.5 0 0.0994108 0.100051 1.21088 119.279 +0.53125 0.15625 -0.15625 0.53125 0 0.0994656 0.1 1.19952 119.279 -0.53125 0.125 -0.125 0.53125 0 0.0993019 0.099995 1.13694 123.592 +0.53125 0.125 -0.125 0.53125 0 0.099302 0.0999951 1.13694 123.592 0.5625 0.125 -0.125 0.5625 0 0.0991816 0.100018 1.12399 123.592 -0.53125 0.15625 -0.15625 0.53125 0 0.0994654 0.1 1.19952 123.592 -0.5625 0.15625 -0.15625 0.5625 0 0.0994444 0.10001 1.18067 123.592 +0.53125 0.15625 -0.15625 0.53125 0 0.0994656 0.1 1.19952 123.592 +0.5625 0.15625 -0.15625 0.5625 0 0.0994445 0.10001 1.18067 123.592 -0.5 0.15625 -0.15625 0.5 0 0.0994098 0.100051 1.21088 386.932 -0.53125 0.15625 -0.15625 0.53125 0 0.0994654 0.1 1.19952 386.932 +0.5 0.15625 -0.15625 0.5 0 0.0994108 0.100051 1.21088 386.932 +0.53125 0.15625 -0.15625 0.53125 0 0.0994656 0.1 1.19952 386.932 -0.5 0.1875 -0.1875 0.5 0 0.0983071 0.100014 1.28953 386.932 -0.53125 0.1875 -0.1875 0.53125 0 0.0984699 0.100001 1.27408 386.932 +0.5 0.1875 -0.1875 0.5 0 0.0983092 0.100014 1.28953 386.932 +0.53125 0.1875 -0.1875 0.53125 0 0.0984704 0.100001 1.27408 386.932 -0.53125 0.15625 -0.15625 0.53125 0 0.0994654 0.1 1.19952 408.27 -0.5625 0.15625 -0.15625 0.5625 0 0.0994444 0.10001 1.18067 408.27 +0.53125 0.15625 -0.15625 0.53125 0 0.0994656 0.1 1.19952 408.27 +0.5625 0.15625 -0.15625 0.5625 0 0.0994445 0.10001 1.18067 408.27 -0.53125 0.1875 -0.1875 0.53125 0 0.0984699 0.100001 1.27408 408.27 -0.5625 0.1875 -0.1875 0.5625 0 0.0984285 0.100003 1.24809 408.27 +0.53125 0.1875 -0.1875 0.53125 0 0.0984704 0.100001 1.27408 408.27 +0.5625 0.1875 -0.1875 0.5625 0 0.0984286 0.100003 1.24809 408.27 0.5625 0.125 -0.125 0.5625 0 0.0991816 0.100018 1.12399 138.74 -0.59375 0.125 -0.125 0.59375 0 0.0997314 0.0999973 1.10892 138.74 +0.59375 0.125 -0.125 0.59375 0 0.0997314 0.0999974 1.10892 138.74 -0.5625 0.15625 -0.15625 0.5625 0 0.0994444 0.10001 1.18067 138.74 -0.59375 0.15625 -0.15625 0.59375 0 0.0998712 0.0999998 1.15868 138.74 +0.5625 0.15625 -0.15625 0.5625 0 0.0994445 0.10001 1.18067 138.74 +0.59375 0.15625 -0.15625 0.59375 0 0.0998713 0.0999998 1.15868 138.74 -0.59375 0.125 -0.125 0.59375 0 0.0997314 0.0999973 1.10892 155.629 +0.59375 0.125 -0.125 0.59375 0 0.0997314 0.0999974 1.10892 155.629 0.625 0.125 -0.125 0.625 0 0.100625 0.100005 1.09141 155.629 -0.59375 0.15625 -0.15625 0.59375 0 0.0998712 0.0999998 1.15868 155.629 +0.59375 0.15625 -0.15625 0.59375 0 0.0998713 0.0999998 1.15868 155.629 0.625 0.15625 -0.15625 0.625 0 0.0999994 0.100002 1.1328 155.629 -0.5625 0.15625 -0.15625 0.5625 0 0.0994444 0.10001 1.18067 415.126 -0.59375 0.15625 -0.15625 0.59375 0 0.0998712 0.0999998 1.15868 415.126 +0.5625 0.15625 -0.15625 0.5625 0 0.0994445 0.10001 1.18067 415.126 +0.59375 0.15625 -0.15625 0.59375 0 0.0998713 0.0999998 1.15868 415.126 -0.5625 0.1875 -0.1875 0.5625 0 0.0984285 0.100003 1.24809 415.126 +0.5625 0.1875 -0.1875 0.5625 0 0.0984286 0.100003 1.24809 415.126 0.59375 0.1875 -0.1875 0.59375 0 0.0993634 0.1 1.21796 415.126 -0.59375 0.15625 -0.15625 0.59375 0 0.0998712 0.0999998 1.15868 246.642 +0.59375 0.15625 -0.15625 0.59375 0 0.0998713 0.0999998 1.15868 246.642 0.625 0.15625 -0.15625 0.625 0 0.0999994 0.100002 1.1328 246.642 0.59375 0.1875 -0.1875 0.59375 0 0.0993634 0.1 1.21796 246.642 0.625 0.1875 -0.1875 0.625 0 0.100743 0.100001 1.18245 246.642 -0.5 0.1875 -0.1875 0.5 0 0.0983071 0.100014 1.28953 641.549 -0.53125 0.1875 -0.1875 0.53125 0 0.0984699 0.100001 1.27408 641.549 +0.5 0.1875 -0.1875 0.5 0 0.0983092 0.100014 1.28953 641.549 +0.53125 0.1875 -0.1875 0.53125 0 0.0984704 0.100001 1.27408 641.549 -0.5 0.21875 -0.21875 0.5 0 0.0992915 0.0999985 1.38429 641.549 -0.53125 0.21875 -0.21875 0.53125 0 0.0994971 0.0999991 1.36306 641.549 +0.5 0.21875 -0.21875 0.5 0 0.0992955 0.0999983 1.38429 641.549 +0.53125 0.21875 -0.21875 0.53125 0 0.0994979 0.0999991 1.36306 641.549 -0.53125 0.1875 -0.1875 0.53125 0 0.0984699 0.100001 1.27408 606.81 -0.5625 0.1875 -0.1875 0.5625 0 0.0984285 0.100003 1.24809 606.81 +0.53125 0.1875 -0.1875 0.53125 0 0.0984704 0.100001 1.27408 606.81 +0.5625 0.1875 -0.1875 0.5625 0 0.0984286 0.100003 1.24809 606.81 -0.53125 0.21875 -0.21875 0.53125 0 0.0994971 0.0999991 1.36306 606.81 -0.5625 0.21875 -0.21875 0.5625 0 0.0996861 0.1 1.32872 606.81 +0.53125 0.21875 -0.21875 0.53125 0 0.0994979 0.0999991 1.36306 606.81 +0.5625 0.21875 -0.21875 0.5625 0 0.0996862 0.1 1.32872 606.81 -0.5625 0.1875 -0.1875 0.5625 0 0.0984285 0.100003 1.24809 610.965 +0.5625 0.1875 -0.1875 0.5625 0 0.0984286 0.100003 1.24809 610.965 0.59375 0.1875 -0.1875 0.59375 0 0.0993634 0.1 1.21796 610.965 -0.5625 0.21875 -0.21875 0.5625 0 0.0996861 0.1 1.32872 610.965 -0.59375 0.21875 -0.21875 0.59375 0 0.0999622 0.1 1.28803 610.965 +0.5625 0.21875 -0.21875 0.5625 0 0.0996862 0.1 1.32872 610.965 +0.59375 0.21875 -0.21875 0.59375 0 0.0999623 0.1 1.28803 610.965 0.59375 0.1875 -0.1875 0.59375 0 0.0993634 0.1 1.21796 349.729 0.625 0.1875 -0.1875 0.625 0 0.100743 0.100001 1.18245 349.729 -0.59375 0.21875 -0.21875 0.59375 0 0.0999622 0.1 1.28803 349.729 +0.59375 0.21875 -0.21875 0.59375 0 0.0999623 0.1 1.28803 349.729 0.625 0.21875 -0.21875 0.625 0 0.0991752 0.1 1.24257 349.729 -0.5625 0.21875 -0.21875 0.5625 0 0.0996861 0.1 1.32872 841.869 -0.59375 0.21875 -0.21875 0.59375 0 0.0999622 0.1 1.28803 841.869 +0.5625 0.21875 -0.21875 0.5625 0 0.0996862 0.1 1.32872 841.869 +0.59375 0.21875 -0.21875 0.59375 0 0.0999623 0.1 1.28803 841.869 0.5625 0.25 -0.25 0.5625 0 0.101217 0.0999989 1.42491 841.869 0.59375 0.25 -0.25 0.59375 0 0.100549 0.0999995 1.37206 841.869 -0.59375 0.21875 -0.21875 0.59375 0 0.0999622 0.1 1.28803 318.554 +0.59375 0.21875 -0.21875 0.59375 0 0.0999623 0.1 1.28803 318.554 0.625 0.21875 -0.21875 0.625 0 0.0991752 0.1 1.24257 318.554 0.59375 0.25 -0.25 0.59375 0 0.100549 0.0999995 1.37206 318.554 @@ -2406,49 +2357,49 @@ 0.875 0.5 -0.5 0.875 0 0.100182 0.1 1.03492 82.2563 -0.125 0.5 -0.5 0.125 0 0.100415 0.100119 1.08562 40.1637 -0.15625 0.5 -0.5 0.15625 0 0.103337 0.100108 1.13164 40.1637 +0.125 0.5 -0.5 0.125 0 0.100415 0.100118 1.08562 40.1637 +0.15625 0.5 -0.5 0.15625 0 0.103337 0.100107 1.13164 40.1637 -0.125 0.53125 -0.53125 0.125 0 0.100571 0.0998956 1.07739 40.1637 +0.125 0.53125 -0.53125 0.125 0 0.100571 0.0998958 1.07739 40.1637 0.15625 0.53125 -0.53125 0.15625 0 0.104279 0.100019 1.11981 40.1637 -0.15625 0.5 -0.5 0.15625 0 0.103337 0.100108 1.13164 279.601 -0.1875 0.5 -0.5 0.1875 0 0.114075 0.0999784 1.1881 279.601 +0.15625 0.5 -0.5 0.15625 0 0.103337 0.100107 1.13164 279.601 +0.1875 0.5 -0.5 0.1875 0 0.114075 0.0999783 1.1881 279.601 0.15625 0.53125 -0.53125 0.15625 0 0.104279 0.100019 1.11981 279.601 -0.1875 0.53125 -0.53125 0.1875 0 0.119246 0.0999405 1.17014 279.601 +0.1875 0.53125 -0.53125 0.1875 0 0.119246 0.0999406 1.17014 279.601 -0.125 0.53125 -0.53125 0.125 0 0.100571 0.0998956 1.07739 78.9716 +0.125 0.53125 -0.53125 0.125 0 0.100571 0.0998958 1.07739 78.9716 0.15625 0.53125 -0.53125 0.15625 0 0.104279 0.100019 1.11981 78.9716 -0.125 0.5625 -0.5625 0.125 0 0.100754 0.100063 1.06777 78.9716 +0.125 0.5625 -0.5625 0.125 0 0.100754 0.100062 1.06777 78.9716 0.15625 0.5625 -0.5625 0.15625 0 0.105522 0.100001 1.10457 78.9716 0.15625 0.53125 -0.53125 0.15625 0 0.104279 0.100019 1.11981 499.995 -0.1875 0.53125 -0.53125 0.1875 0 0.119246 0.0999405 1.17014 499.995 +0.1875 0.53125 -0.53125 0.1875 0 0.119246 0.0999406 1.17014 499.995 0.15625 0.5625 -0.5625 0.15625 0 0.105522 0.100001 1.10457 499.995 0.1875 0.5625 -0.5625 0.1875 0 0.12547 0.100022 1.1486 499.995 -0.1875 0.5 -0.5 0.1875 0 0.114075 0.0999784 1.1881 994.281 -0.21875 0.5 -0.5 0.21875 0 0.232387 0.100014 1.26269 994.281 +0.1875 0.5 -0.5 0.1875 0 0.114075 0.0999783 1.1881 994.281 +0.21875 0.5 -0.5 0.21875 0 0.232387 0.100013 1.26269 994.281 -0.1875 0.53125 -0.53125 0.1875 0 0.119246 0.0999405 1.17014 994.281 +0.1875 0.53125 -0.53125 0.1875 0 0.119246 0.0999406 1.17014 994.281 0.21875 0.53125 -0.53125 0.21875 0 0.24557 0.0999776 1.23785 994.281 -0.21875 0.5 -0.5 0.21875 0 0.232387 0.100014 1.26269 426.682 +0.21875 0.5 -0.5 0.21875 0 0.232387 0.100013 1.26269 426.682 0.25 0.5 -0.5 0.25 0 0.462289 0.0999841 1.35065 426.682 0.21875 0.53125 -0.53125 0.21875 0 0.24557 0.0999776 1.23785 426.682 0.25 0.53125 -0.53125 0.25 0 0.47101 0.0999705 1.31715 426.682 -0.1875 0.53125 -0.53125 0.1875 0 0.119246 0.0999405 1.17014 841.07 +0.1875 0.53125 -0.53125 0.1875 0 0.119246 0.0999406 1.17014 841.07 0.21875 0.53125 -0.53125 0.21875 0 0.24557 0.0999776 1.23785 841.07 0.1875 0.5625 -0.5625 0.1875 0 0.12547 0.100022 1.1486 841.07 @@ -2462,28 +2413,28 @@ 0.25 0.5625 -0.5625 0.25 0 0.479684 0.100005 1.27661 332.458 -0.125 0.5625 -0.5625 0.125 0 0.100754 0.100063 1.06777 94.7998 +0.125 0.5625 -0.5625 0.125 0 0.100754 0.100062 1.06777 94.7998 0.15625 0.5625 -0.5625 0.15625 0 0.105522 0.100001 1.10457 94.7998 0.125 0.59375 -0.59375 0.125 0 0.100984 0.100024 1.05716 94.7998 -0.15625 0.59375 -0.59375 0.15625 0 0.107174 0.0999893 1.0879 94.7998 +0.15625 0.59375 -0.59375 0.15625 0 0.107174 0.0999894 1.0879 94.7998 0.15625 0.5625 -0.5625 0.15625 0 0.105522 0.100001 1.10457 644.334 0.1875 0.5625 -0.5625 0.1875 0 0.12547 0.100022 1.1486 644.334 -0.15625 0.59375 -0.59375 0.15625 0 0.107174 0.0999893 1.0879 644.334 +0.15625 0.59375 -0.59375 0.15625 0 0.107174 0.0999894 1.0879 644.334 0.1875 0.59375 -0.59375 0.1875 0 0.132543 0.100019 1.12489 644.334 0.125 0.59375 -0.59375 0.125 0 0.100984 0.100024 1.05716 132.351 -0.15625 0.59375 -0.59375 0.15625 0 0.107174 0.0999893 1.0879 132.351 +0.15625 0.59375 -0.59375 0.15625 0 0.107174 0.0999894 1.0879 132.351 0.125 0.625 -0.625 0.125 0 0.100908 0.0999875 1.04633 132.351 0.15625 0.625 -0.625 0.15625 0 0.106569 0.100008 1.07114 132.351 -0.15625 0.59375 -0.59375 0.15625 0 0.107174 0.0999893 1.0879 716.791 +0.15625 0.59375 -0.59375 0.15625 0 0.107174 0.0999894 1.0879 716.791 0.1875 0.59375 -0.59375 0.1875 0 0.132543 0.100019 1.12489 716.791 0.15625 0.625 -0.625 0.15625 0 0.106569 0.100008 1.07114 716.791 @@ -3379,150 +3330,178 @@ 0.625 0.8125 -0.8125 0.625 0 0.0994213 0.1 1.03561 1544.91 -0.40625 0.21875 -0.21875 0.40625 0 0.098266 0.0998355 1.35902 206.455 -0.421875 0.21875 -0.21875 0.421875 0 0.0993116 0.100045 1.37306 206.455 +0.375 0.21875 -0.21875 0.375 0 0.0998429 0.0995912 1.32548 79.4892 +0.390625 0.21875 -0.21875 0.390625 0 0.0997104 0.100109 1.34448 79.4892 + +0.375 0.234375 -0.234375 0.375 0 0.0995793 0.0995087 1.37127 79.4892 +0.390625 0.234375 -0.234375 0.390625 0 0.100383 0.100077 1.39377 79.4892 + + +0.390625 0.21875 -0.21875 0.390625 0 0.0997104 0.100109 1.34448 215.496 +0.40625 0.21875 -0.21875 0.40625 0 0.098632 0.099826 1.35903 215.496 + +0.390625 0.234375 -0.234375 0.390625 0 0.100383 0.100077 1.39377 215.496 +0.40625 0.234375 -0.234375 0.40625 0 0.100625 0.0997736 1.41005 215.496 + + +0.375 0.234375 -0.234375 0.375 0 0.0995793 0.0995087 1.37127 151.928 +0.390625 0.234375 -0.234375 0.390625 0 0.100383 0.100077 1.39377 151.928 + +0.375 0.25 -0.25 0.375 0 0.102079 0.100066 1.41792 151.928 +0.390625 0.25 -0.25 0.390625 0 0.100252 0.0999848 1.44411 151.928 + + +0.390625 0.234375 -0.234375 0.390625 0 0.100383 0.100077 1.39377 100.796 +0.40625 0.234375 -0.234375 0.40625 0 0.100625 0.0997736 1.41005 100.796 + +0.390625 0.25 -0.25 0.390625 0 0.100252 0.0999848 1.44411 100.796 +0.40625 0.25 -0.25 0.40625 0 0.100339 0.0999714 1.46168 100.796 + + +0.40625 0.21875 -0.21875 0.40625 0 0.098632 0.099826 1.35903 206.455 +0.421875 0.21875 -0.21875 0.421875 0 0.0992396 0.100047 1.37306 206.455 -0.40625 0.234375 -0.234375 0.40625 0 0.100435 0.0996983 1.40995 206.455 -0.421875 0.234375 -0.234375 0.421875 0 0.100635 0.100009 1.42549 206.455 +0.40625 0.234375 -0.234375 0.40625 0 0.100625 0.0997736 1.41005 206.455 +0.421875 0.234375 -0.234375 0.421875 0 0.100632 0.100039 1.42553 206.455 -0.421875 0.21875 -0.21875 0.421875 0 0.0993116 0.100045 1.37306 209.468 -0.4375 0.21875 -0.21875 0.4375 0 0.0988297 0.0999581 1.38363 209.468 +0.421875 0.21875 -0.21875 0.421875 0 0.0992396 0.100047 1.37306 209.468 +0.4375 0.21875 -0.21875 0.4375 0 0.0989142 0.0999557 1.38364 209.468 -0.421875 0.234375 -0.234375 0.421875 0 0.100635 0.100009 1.42549 209.468 -0.4375 0.234375 -0.234375 0.4375 0 0.100687 0.0998996 1.43591 209.468 +0.421875 0.234375 -0.234375 0.421875 0 0.100632 0.100039 1.42553 209.468 +0.4375 0.234375 -0.234375 0.4375 0 0.10067 0.0999107 1.43593 209.468 -0.40625 0.234375 -0.234375 0.40625 0 0.100435 0.0996983 1.40995 91.8853 -0.421875 0.234375 -0.234375 0.421875 0 0.100635 0.100009 1.42549 91.8853 +0.40625 0.234375 -0.234375 0.40625 0 0.100625 0.0997736 1.41005 91.8853 +0.421875 0.234375 -0.234375 0.421875 0 0.100632 0.100039 1.42553 91.8853 -0.40625 0.25 -0.25 0.40625 0 0.100583 0.0999467 1.46136 91.8853 -0.421875 0.25 -0.25 0.421875 0 0.100063 0.0999898 1.48088 91.8853 +0.40625 0.25 -0.25 0.40625 0 0.100339 0.0999714 1.46168 91.8853 +0.421875 0.25 -0.25 0.421875 0 0.100011 0.100003 1.48102 91.8853 -0.421875 0.234375 -0.234375 0.421875 0 0.100635 0.100009 1.42549 129.907 -0.4375 0.234375 -0.234375 0.4375 0 0.100687 0.0998996 1.43591 129.907 +0.421875 0.234375 -0.234375 0.421875 0 0.100632 0.100039 1.42553 129.907 +0.4375 0.234375 -0.234375 0.4375 0 0.10067 0.0999107 1.43593 129.907 -0.421875 0.25 -0.25 0.421875 0 0.100063 0.0999898 1.48088 129.907 -0.4375 0.25 -0.25 0.4375 0 0.0998798 0.0999578 1.49466 129.907 +0.421875 0.25 -0.25 0.421875 0 0.100011 0.100003 1.48102 129.907 +0.4375 0.25 -0.25 0.4375 0 0.0998724 0.0999646 1.49472 129.907 -0.4375 0.21875 -0.21875 0.4375 0 0.0988297 0.0999581 1.38363 214.035 -0.453125 0.21875 -0.21875 0.453125 0 0.0990444 0.10001 1.38895 214.035 +0.4375 0.21875 -0.21875 0.4375 0 0.0989142 0.0999557 1.38364 214.035 +0.453125 0.21875 -0.21875 0.453125 0 0.0990285 0.100011 1.38895 214.035 -0.4375 0.234375 -0.234375 0.4375 0 0.100687 0.0998996 1.43591 214.035 -0.453125 0.234375 -0.234375 0.453125 0 0.100786 0.100009 1.44288 214.035 +0.4375 0.234375 -0.234375 0.4375 0 0.10067 0.0999107 1.43593 214.035 +0.453125 0.234375 -0.234375 0.453125 0 0.100775 0.100013 1.44288 214.035 -0.453125 0.21875 -0.21875 0.453125 0 0.0990444 0.10001 1.38895 220.412 -0.46875 0.21875 -0.21875 0.46875 0 0.0990848 0.0999841 1.39124 220.412 +0.453125 0.21875 -0.21875 0.453125 0 0.0990285 0.100011 1.38895 220.412 +0.46875 0.21875 -0.21875 0.46875 0 0.0991035 0.0999836 1.39124 220.412 -0.453125 0.234375 -0.234375 0.453125 0 0.100786 0.100009 1.44288 220.412 -0.46875 0.234375 -0.234375 0.46875 0 0.100734 0.0999661 1.44536 220.412 +0.453125 0.234375 -0.234375 0.453125 0 0.100775 0.100013 1.44288 220.412 +0.46875 0.234375 -0.234375 0.46875 0 0.100731 0.0999674 1.44536 220.412 -0.4375 0.234375 -0.234375 0.4375 0 0.100687 0.0998996 1.43591 165.198 -0.453125 0.234375 -0.234375 0.453125 0 0.100786 0.100009 1.44288 165.198 +0.4375 0.234375 -0.234375 0.4375 0 0.10067 0.0999107 1.43593 165.198 +0.453125 0.234375 -0.234375 0.453125 0 0.100775 0.100013 1.44288 165.198 -0.4375 0.25 -0.25 0.4375 0 0.0998798 0.0999578 1.49466 165.198 -0.453125 0.25 -0.25 0.453125 0 0.0995923 0.1 1.5023 165.198 +0.4375 0.25 -0.25 0.4375 0 0.0998724 0.0999646 1.49472 165.198 +0.453125 0.25 -0.25 0.453125 0 0.0995925 0.100004 1.50232 165.198 -0.453125 0.234375 -0.234375 0.453125 0 0.100786 0.100009 1.44288 171.725 -0.46875 0.234375 -0.234375 0.46875 0 0.100734 0.0999661 1.44536 171.725 +0.453125 0.234375 -0.234375 0.453125 0 0.100775 0.100013 1.44288 171.725 +0.46875 0.234375 -0.234375 0.46875 0 0.100731 0.0999674 1.44536 171.725 -0.453125 0.25 -0.25 0.453125 0 0.0995923 0.1 1.5023 171.725 -0.46875 0.25 -0.25 0.46875 0 0.0999802 0.0999788 1.50508 171.725 +0.453125 0.25 -0.25 0.453125 0 0.0995925 0.100004 1.50232 171.725 +0.46875 0.25 -0.25 0.46875 0 0.0999809 0.0999802 1.50508 171.725 -0.46875 0.21875 -0.21875 0.46875 0 0.0990848 0.0999841 1.39124 225.651 -0.484375 0.21875 -0.21875 0.484375 0 0.0992282 0.100003 1.38949 225.651 +0.46875 0.21875 -0.21875 0.46875 0 0.0991035 0.0999836 1.39124 225.651 +0.484375 0.21875 -0.21875 0.484375 0 0.0992247 0.100003 1.38949 225.651 -0.46875 0.234375 -0.234375 0.46875 0 0.100734 0.0999661 1.44536 225.651 -0.484375 0.234375 -0.234375 0.484375 0 0.10078 0.100004 1.44358 225.651 +0.46875 0.234375 -0.234375 0.46875 0 0.100731 0.0999674 1.44536 225.651 +0.484375 0.234375 -0.234375 0.484375 0 0.100779 0.100005 1.44358 225.651 -0.484375 0.21875 -0.21875 0.484375 0 0.0992282 0.100003 1.38949 232.133 -0.5 0.21875 -0.21875 0.5 0 0.0992915 0.0999985 1.38429 232.133 +0.484375 0.21875 -0.21875 0.484375 0 0.0992247 0.100003 1.38949 232.133 +0.5 0.21875 -0.21875 0.5 0 0.0992955 0.0999983 1.38429 232.133 -0.484375 0.234375 -0.234375 0.484375 0 0.10078 0.100004 1.44358 232.133 -0.5 0.234375 -0.234375 0.5 0 0.100776 0.09999 1.43758 232.133 +0.484375 0.234375 -0.234375 0.484375 0 0.100779 0.100005 1.44358 232.133 +0.5 0.234375 -0.234375 0.5 0 0.100776 0.0999901 1.43758 232.133 -0.46875 0.234375 -0.234375 0.46875 0 0.100734 0.0999661 1.44536 163.176 -0.484375 0.234375 -0.234375 0.484375 0 0.10078 0.100004 1.44358 163.176 +0.46875 0.234375 -0.234375 0.46875 0 0.100731 0.0999674 1.44536 163.176 +0.484375 0.234375 -0.234375 0.484375 0 0.100779 0.100005 1.44358 163.176 -0.46875 0.25 -0.25 0.46875 0 0.0999802 0.0999788 1.50508 163.176 +0.46875 0.25 -0.25 0.46875 0 0.0999809 0.0999802 1.50508 163.176 0.484375 0.25 -0.25 0.484375 0 0.10007 0.100002 1.50311 163.176 -0.484375 0.234375 -0.234375 0.484375 0 0.10078 0.100004 1.44358 164.875 -0.5 0.234375 -0.234375 0.5 0 0.100776 0.09999 1.43758 164.875 +0.484375 0.234375 -0.234375 0.484375 0 0.100779 0.100005 1.44358 164.875 +0.5 0.234375 -0.234375 0.5 0 0.100776 0.0999901 1.43758 164.875 0.484375 0.25 -0.25 0.484375 0 0.10007 0.100002 1.50311 164.875 -0.5 0.25 -0.25 0.5 0 0.10027 0.0999904 1.49634 164.875 +0.5 0.25 -0.25 0.5 0 0.10027 0.0999906 1.49634 164.875 -0.34375 0.25 -0.25 0.34375 0 0.103571 0.0999891 1.36211 693.041 -0.359375 0.25 -0.25 0.359375 0 0.102362 0.099908 1.38972 693.041 +0.34375 0.25 -0.25 0.34375 0 0.10358 0.099989 1.3621 693.041 +0.359375 0.25 -0.25 0.359375 0 0.102354 0.099906 1.38973 693.041 -0.34375 0.265625 -0.265625 0.34375 0 0.0892929 0.0999729 1.40447 693.041 -0.359375 0.265625 -0.265625 0.359375 0 0.0973093 0.0999884 1.43661 693.041 +0.34375 0.265625 -0.265625 0.34375 0 0.0892922 0.0999714 1.40447 693.041 +0.359375 0.265625 -0.265625 0.359375 0 0.0973118 0.0999877 1.4366 693.041 -0.359375 0.25 -0.25 0.359375 0 0.102362 0.099908 1.38972 570.545 -0.375 0.25 -0.25 0.375 0 0.101953 0.100065 1.41803 570.545 +0.359375 0.25 -0.25 0.359375 0 0.102354 0.099906 1.38973 570.545 +0.375 0.25 -0.25 0.375 0 0.102079 0.100066 1.41792 570.545 -0.359375 0.265625 -0.265625 0.359375 0 0.0973093 0.0999884 1.43661 570.545 -0.375 0.265625 -0.265625 0.375 0 0.112998 0.100125 1.46853 570.545 +0.359375 0.265625 -0.265625 0.359375 0 0.0973118 0.0999877 1.4366 570.545 +0.375 0.265625 -0.265625 0.375 0 0.113002 0.100125 1.46853 570.545 -0.34375 0.265625 -0.265625 0.34375 0 0.0892929 0.0999729 1.40447 477.639 -0.359375 0.265625 -0.265625 0.359375 0 0.0973093 0.0999884 1.43661 477.639 +0.34375 0.265625 -0.265625 0.34375 0 0.0892922 0.0999714 1.40447 477.639 +0.359375 0.265625 -0.265625 0.359375 0 0.0973118 0.0999877 1.4366 477.639 -0.34375 0.28125 -0.28125 0.34375 0 0.0757971 0.0998589 1.44892 477.639 +0.34375 0.28125 -0.28125 0.34375 0 0.075798 0.0998593 1.44892 477.639 0.359375 0.28125 -0.28125 0.359375 0 0.105975 0.100013 1.48586 477.639 -0.359375 0.265625 -0.265625 0.359375 0 0.0973093 0.0999884 1.43661 468.923 -0.375 0.265625 -0.265625 0.375 0 0.112998 0.100125 1.46853 468.923 +0.359375 0.265625 -0.265625 0.359375 0 0.0973118 0.0999877 1.4366 468.923 +0.375 0.265625 -0.265625 0.375 0 0.113002 0.100125 1.46853 468.923 0.359375 0.28125 -0.28125 0.359375 0 0.105975 0.100013 1.48586 468.923 0.375 0.28125 -0.28125 0.375 0 0.167524 0.0999595 1.51876 468.923 -0.3125 0.28125 -0.28125 0.3125 0 0.08409 0.099566 1.37686 452.897 -0.328125 0.28125 -0.28125 0.328125 0 0.0770778 0.100083 1.41531 452.897 +0.3125 0.28125 -0.28125 0.3125 0 0.0840902 0.0995666 1.37686 452.897 +0.328125 0.28125 -0.28125 0.328125 0 0.0770776 0.100083 1.41531 452.897 -0.3125 0.296875 -0.296875 0.3125 0 0.101315 0.0994223 1.41332 452.897 +0.3125 0.296875 -0.296875 0.3125 0 0.101315 0.0994225 1.41332 452.897 0.328125 0.296875 -0.296875 0.328125 0 0.0955543 0.100095 1.45601 452.897 -0.328125 0.28125 -0.28125 0.328125 0 0.0770778 0.100083 1.41531 581.385 -0.34375 0.28125 -0.28125 0.34375 0 0.0757971 0.0998589 1.44892 581.385 +0.328125 0.28125 -0.28125 0.328125 0 0.0770776 0.100083 1.41531 581.385 +0.34375 0.28125 -0.28125 0.34375 0 0.075798 0.0998593 1.44892 581.385 0.328125 0.296875 -0.296875 0.328125 0 0.0955543 0.100095 1.45601 581.385 -0.34375 0.296875 -0.296875 0.34375 0 0.103201 0.0996909 1.49275 581.385 +0.34375 0.296875 -0.296875 0.34375 0 0.103201 0.099691 1.49275 581.385 -0.3125 0.296875 -0.296875 0.3125 0 0.101315 0.0994223 1.41332 502.593 +0.3125 0.296875 -0.296875 0.3125 0 0.101315 0.0994225 1.41332 502.593 0.328125 0.296875 -0.296875 0.328125 0 0.0955543 0.100095 1.45601 502.593 -0.3125 0.3125 -0.3125 0.3125 0 0.157764 0.0995807 1.44813 502.593 +0.3125 0.3125 -0.3125 0.3125 0 0.157764 0.0995808 1.44813 502.593 0.328125 0.3125 -0.3125 0.328125 0 0.190899 0.100029 1.49427 502.593 0.328125 0.296875 -0.296875 0.328125 0 0.0955543 0.100095 1.45601 484.326 -0.34375 0.296875 -0.296875 0.34375 0 0.103201 0.0996909 1.49275 484.326 +0.34375 0.296875 -0.296875 0.34375 0 0.103201 0.099691 1.49275 484.326 0.328125 0.3125 -0.3125 0.328125 0 0.190899 0.100029 1.49427 484.326 -0.34375 0.3125 -0.3125 0.34375 0 0.203806 0.0997334 1.5339 484.326 +0.34375 0.3125 -0.3125 0.34375 0 0.203806 0.0997335 1.5339 484.326 -0.34375 0.28125 -0.28125 0.34375 0 0.0757971 0.0998589 1.44892 910.553 +0.34375 0.28125 -0.28125 0.34375 0 0.075798 0.0998593 1.44892 910.553 0.359375 0.28125 -0.28125 0.359375 0 0.105975 0.100013 1.48586 910.553 -0.34375 0.296875 -0.296875 0.34375 0 0.103201 0.0996909 1.49275 910.553 +0.34375 0.296875 -0.296875 0.34375 0 0.103201 0.099691 1.49275 910.553 0.359375 0.296875 -0.296875 0.359375 0 0.16015 0.100046 1.5331 910.553 @@ -3533,10 +3512,10 @@ 0.375 0.296875 -0.296875 0.375 0 0.274573 0.0998615 1.56766 782.861 -0.34375 0.296875 -0.296875 0.34375 0 0.103201 0.0996909 1.49275 610.847 +0.34375 0.296875 -0.296875 0.34375 0 0.103201 0.099691 1.49275 610.847 0.359375 0.296875 -0.296875 0.359375 0 0.16015 0.100046 1.5331 610.847 -0.34375 0.3125 -0.3125 0.34375 0 0.203806 0.0997334 1.5339 610.847 +0.34375 0.3125 -0.3125 0.34375 0 0.203806 0.0997335 1.5339 610.847 0.359375 0.3125 -0.3125 0.359375 0 0.267551 0.100035 1.57787 610.847 @@ -3550,74 +3529,74 @@ 0.28125 0.3125 -0.3125 0.28125 0 0.108752 0.0998542 1.35917 714.163 0.296875 0.3125 -0.3125 0.296875 0 0.126547 0.100029 1.40138 714.163 -0.28125 0.328125 -0.328125 0.28125 0 0.145604 0.099465 1.38619 714.163 -0.296875 0.328125 -0.328125 0.296875 0 0.205822 0.0998715 1.43405 714.163 +0.28125 0.328125 -0.328125 0.28125 0 0.145604 0.0994643 1.38619 714.163 +0.296875 0.328125 -0.328125 0.296875 0 0.205822 0.0998712 1.43405 714.163 0.296875 0.3125 -0.3125 0.296875 0 0.126547 0.100029 1.40138 1496.77 -0.3125 0.3125 -0.3125 0.3125 0 0.157764 0.0995807 1.44813 1496.77 +0.3125 0.3125 -0.3125 0.3125 0 0.157764 0.0995808 1.44813 1496.77 -0.296875 0.328125 -0.328125 0.296875 0 0.205822 0.0998715 1.43405 1496.77 -0.3125 0.328125 -0.328125 0.3125 0 0.288472 0.0998082 1.48298 1496.77 +0.296875 0.328125 -0.328125 0.296875 0 0.205822 0.0998712 1.43405 1496.77 +0.3125 0.328125 -0.328125 0.3125 0 0.288472 0.0998081 1.48298 1496.77 -0.28125 0.328125 -0.328125 0.28125 0 0.145604 0.099465 1.38619 293.001 -0.296875 0.328125 -0.328125 0.296875 0 0.205822 0.0998715 1.43405 293.001 +0.28125 0.328125 -0.328125 0.28125 0 0.145604 0.0994643 1.38619 293.001 +0.296875 0.328125 -0.328125 0.296875 0 0.205822 0.0998712 1.43405 293.001 -0.28125 0.34375 -0.34375 0.28125 0 0.224569 0.0993848 1.41182 293.001 +0.28125 0.34375 -0.34375 0.28125 0 0.224569 0.0993849 1.41182 293.001 0.296875 0.34375 -0.34375 0.296875 0 0.326978 0.0999459 1.46385 293.001 -0.296875 0.328125 -0.328125 0.296875 0 0.205822 0.0998715 1.43405 660.067 -0.3125 0.328125 -0.328125 0.3125 0 0.288472 0.0998082 1.48298 660.067 +0.296875 0.328125 -0.328125 0.296875 0 0.205822 0.0998712 1.43405 660.067 +0.3125 0.328125 -0.328125 0.3125 0 0.288472 0.0998081 1.48298 660.067 0.296875 0.34375 -0.34375 0.296875 0 0.326978 0.0999459 1.46385 660.067 0.3125 0.34375 -0.34375 0.3125 0 0.409557 0.0997361 1.51372 660.067 -0.28125 0.34375 -0.34375 0.28125 0 0.224569 0.0993848 1.41182 213.915 +0.28125 0.34375 -0.34375 0.28125 0 0.224569 0.0993849 1.41182 213.915 0.296875 0.34375 -0.34375 0.296875 0 0.326978 0.0999459 1.46385 213.915 -0.28125 0.359375 -0.359375 0.28125 0 0.317666 0.0994301 1.43429 213.915 -0.296875 0.359375 -0.359375 0.296875 0 0.430032 0.0999789 1.48942 213.915 +0.28125 0.359375 -0.359375 0.28125 0 0.317666 0.0994305 1.43429 213.915 +0.296875 0.359375 -0.359375 0.296875 0 0.430032 0.0999791 1.48942 213.915 0.296875 0.34375 -0.34375 0.296875 0 0.326978 0.0999459 1.46385 1683.51 0.3125 0.34375 -0.34375 0.3125 0 0.409557 0.0997361 1.51372 1683.51 -0.296875 0.359375 -0.359375 0.296875 0 0.430032 0.0999789 1.48942 1683.51 -0.3125 0.359375 -0.359375 0.3125 0 0.480587 0.0997384 1.54049 1683.51 +0.296875 0.359375 -0.359375 0.296875 0 0.430032 0.0999791 1.48942 1683.51 +0.3125 0.359375 -0.359375 0.3125 0 0.480587 0.0997385 1.54049 1683.51 -0.28125 0.359375 -0.359375 0.28125 0 0.317666 0.0994301 1.43429 305.276 -0.296875 0.359375 -0.359375 0.296875 0 0.430032 0.0999789 1.48942 305.276 +0.28125 0.359375 -0.359375 0.28125 0 0.317666 0.0994305 1.43429 305.276 +0.296875 0.359375 -0.359375 0.296875 0 0.430032 0.0999791 1.48942 305.276 -0.28125 0.375 -0.375 0.28125 0 0.370069 0.0989537 1.4532 305.276 +0.28125 0.375 -0.375 0.28125 0 0.370069 0.0989536 1.4532 305.276 0.296875 0.375 -0.375 0.296875 0 0.479969 0.0999121 1.50947 305.276 -0.296875 0.359375 -0.359375 0.296875 0 0.430032 0.0999789 1.48942 1802.47 -0.3125 0.359375 -0.359375 0.3125 0 0.480587 0.0997384 1.54049 1802.47 +0.296875 0.359375 -0.359375 0.296875 0 0.430032 0.0999791 1.48942 1802.47 +0.3125 0.359375 -0.359375 0.3125 0 0.480587 0.0997385 1.54049 1802.47 0.296875 0.375 -0.375 0.296875 0 0.479969 0.0999121 1.50947 1802.47 0.3125 0.375 -0.375 0.3125 0 0.508035 0.0995538 1.56391 1802.47 -0.3125 0.3125 -0.3125 0.3125 0 0.157764 0.0995807 1.44813 399.344 +0.3125 0.3125 -0.3125 0.3125 0 0.157764 0.0995808 1.44813 399.344 0.328125 0.3125 -0.3125 0.328125 0 0.190899 0.100029 1.49427 399.344 -0.3125 0.328125 -0.328125 0.3125 0 0.288472 0.0998082 1.48298 399.344 +0.3125 0.328125 -0.328125 0.3125 0 0.288472 0.0998081 1.48298 399.344 0.328125 0.328125 -0.328125 0.328125 0 0.35325 0.0999977 1.53039 399.344 0.328125 0.3125 -0.3125 0.328125 0 0.190899 0.100029 1.49427 347.92 -0.34375 0.3125 -0.3125 0.34375 0 0.203806 0.0997334 1.5339 347.92 +0.34375 0.3125 -0.3125 0.34375 0 0.203806 0.0997335 1.5339 347.92 0.328125 0.328125 -0.328125 0.328125 0 0.35325 0.0999977 1.53039 347.92 0.34375 0.328125 -0.328125 0.34375 0 0.373139 0.0999094 1.57529 347.92 -0.3125 0.328125 -0.328125 0.3125 0 0.288472 0.0998082 1.48298 449.704 +0.3125 0.328125 -0.328125 0.3125 0 0.288472 0.0998081 1.48298 449.704 0.328125 0.328125 -0.328125 0.328125 0 0.35325 0.0999977 1.53039 449.704 0.3125 0.34375 -0.34375 0.3125 0 0.409557 0.0997361 1.51372 449.704 @@ -3631,7 +3610,7 @@ 0.34375 0.34375 -0.34375 0.34375 0 0.476052 0.0998945 1.61269 538.658 -0.34375 0.3125 -0.3125 0.34375 0 0.203806 0.0997334 1.5339 353.095 +0.34375 0.3125 -0.3125 0.34375 0 0.203806 0.0997335 1.5339 353.095 0.359375 0.3125 -0.3125 0.359375 0 0.267551 0.100035 1.57787 353.095 0.34375 0.328125 -0.328125 0.34375 0 0.373139 0.0999094 1.57529 353.095 @@ -3662,7 +3641,7 @@ 0.3125 0.34375 -0.34375 0.3125 0 0.409557 0.0997361 1.51372 430.226 0.328125 0.34375 -0.34375 0.328125 0 0.460228 0.0999903 1.5639 430.226 -0.3125 0.359375 -0.359375 0.3125 0 0.480587 0.0997384 1.54049 430.226 +0.3125 0.359375 -0.359375 0.3125 0 0.480587 0.0997385 1.54049 430.226 0.328125 0.359375 -0.359375 0.328125 0 0.49293 0.100003 1.59426 430.226 @@ -3673,7 +3652,7 @@ 0.34375 0.359375 -0.359375 0.34375 0 0.496833 0.0998813 1.64524 530.932 -0.3125 0.359375 -0.359375 0.3125 0 0.480587 0.0997384 1.54049 104.26 +0.3125 0.359375 -0.359375 0.3125 0 0.480587 0.0997385 1.54049 104.26 0.328125 0.359375 -0.359375 0.328125 0 0.49293 0.100003 1.59426 104.26 0.3125 0.375 -0.375 0.3125 0 0.508035 0.0995538 1.56391 104.26 @@ -3715,70 +3694,70 @@ 0.375 0.375 -0.375 0.375 0 0.501226 0.0999288 1.77272 128.003 -0.375 0.25 -0.25 0.375 0 0.101953 0.100065 1.41803 682.15 -0.390625 0.25 -0.25 0.390625 0 0.100093 0.100009 1.4441 682.15 +0.375 0.25 -0.25 0.375 0 0.102079 0.100066 1.41792 682.15 +0.390625 0.25 -0.25 0.390625 0 0.100252 0.0999848 1.44411 682.15 -0.375 0.265625 -0.265625 0.375 0 0.112998 0.100125 1.46853 682.15 -0.390625 0.265625 -0.265625 0.390625 0 0.119623 0.0999642 1.4954 682.15 +0.375 0.265625 -0.265625 0.375 0 0.113002 0.100125 1.46853 682.15 +0.390625 0.265625 -0.265625 0.390625 0 0.119621 0.0999645 1.4954 682.15 -0.390625 0.25 -0.25 0.390625 0 0.100093 0.100009 1.4441 1117.45 -0.40625 0.25 -0.25 0.40625 0 0.100583 0.0999467 1.46136 1117.45 +0.390625 0.25 -0.25 0.390625 0 0.100252 0.0999848 1.44411 1117.45 +0.40625 0.25 -0.25 0.40625 0 0.100339 0.0999714 1.46168 1117.45 -0.390625 0.265625 -0.265625 0.390625 0 0.119623 0.0999642 1.4954 1117.45 -0.40625 0.265625 -0.265625 0.40625 0 0.119338 0.100072 1.51667 1117.45 +0.390625 0.265625 -0.265625 0.390625 0 0.119621 0.0999645 1.4954 1117.45 +0.40625 0.265625 -0.265625 0.40625 0 0.119332 0.100072 1.51667 1117.45 -0.375 0.265625 -0.265625 0.375 0 0.112998 0.100125 1.46853 296.039 -0.390625 0.265625 -0.265625 0.390625 0 0.119623 0.0999642 1.4954 296.039 +0.375 0.265625 -0.265625 0.375 0 0.113002 0.100125 1.46853 296.039 +0.390625 0.265625 -0.265625 0.390625 0 0.119621 0.0999645 1.4954 296.039 0.375 0.28125 -0.28125 0.375 0 0.167524 0.0999595 1.51876 296.039 -0.390625 0.28125 -0.28125 0.390625 0 0.208371 0.0999978 1.54758 296.039 +0.390625 0.28125 -0.28125 0.390625 0 0.20837 0.0999977 1.54758 296.039 -0.390625 0.265625 -0.265625 0.390625 0 0.119623 0.0999642 1.4954 128.634 -0.40625 0.265625 -0.265625 0.40625 0 0.119338 0.100072 1.51667 128.634 +0.390625 0.265625 -0.265625 0.390625 0 0.119621 0.0999645 1.4954 128.634 +0.40625 0.265625 -0.265625 0.40625 0 0.119332 0.100072 1.51667 128.634 -0.390625 0.28125 -0.28125 0.390625 0 0.208371 0.0999978 1.54758 128.634 +0.390625 0.28125 -0.28125 0.390625 0 0.20837 0.0999977 1.54758 128.634 0.40625 0.28125 -0.28125 0.40625 0 0.216713 0.100007 1.57207 128.634 -0.40625 0.25 -0.25 0.40625 0 0.100583 0.0999467 1.46136 1181.49 -0.421875 0.25 -0.25 0.421875 0 0.100063 0.0999898 1.48088 1181.49 +0.40625 0.25 -0.25 0.40625 0 0.100339 0.0999714 1.46168 1181.49 +0.421875 0.25 -0.25 0.421875 0 0.100011 0.100003 1.48102 1181.49 -0.40625 0.265625 -0.265625 0.40625 0 0.119338 0.100072 1.51667 1181.49 -0.421875 0.265625 -0.265625 0.421875 0 0.115166 0.099988 1.53582 1181.49 +0.40625 0.265625 -0.265625 0.40625 0 0.119332 0.100072 1.51667 1181.49 +0.421875 0.265625 -0.265625 0.421875 0 0.115165 0.0999879 1.53582 1181.49 -0.421875 0.25 -0.25 0.421875 0 0.100063 0.0999898 1.48088 1148.01 -0.4375 0.25 -0.25 0.4375 0 0.0998798 0.0999578 1.49466 1148.01 +0.421875 0.25 -0.25 0.421875 0 0.100011 0.100003 1.48102 1148.01 +0.4375 0.25 -0.25 0.4375 0 0.0998724 0.0999646 1.49472 1148.01 -0.421875 0.265625 -0.265625 0.421875 0 0.115166 0.099988 1.53582 1148.01 -0.4375 0.265625 -0.265625 0.4375 0 0.113305 0.100028 1.54852 1148.01 +0.421875 0.265625 -0.265625 0.421875 0 0.115165 0.0999879 1.53582 1148.01 +0.4375 0.265625 -0.265625 0.4375 0 0.113305 0.100028 1.54853 1148.01 -0.40625 0.265625 -0.265625 0.40625 0 0.119338 0.100072 1.51667 178.996 -0.421875 0.265625 -0.265625 0.421875 0 0.115166 0.099988 1.53582 178.996 +0.40625 0.265625 -0.265625 0.40625 0 0.119332 0.100072 1.51667 178.996 +0.421875 0.265625 -0.265625 0.421875 0 0.115165 0.0999879 1.53582 178.996 0.40625 0.28125 -0.28125 0.40625 0 0.216713 0.100007 1.57207 178.996 0.421875 0.28125 -0.28125 0.421875 0 0.20415 0.0999976 1.59326 178.996 -0.421875 0.265625 -0.265625 0.421875 0 0.115166 0.099988 1.53582 330.581 -0.4375 0.265625 -0.265625 0.4375 0 0.113305 0.100028 1.54852 330.581 +0.421875 0.265625 -0.265625 0.421875 0 0.115165 0.0999879 1.53582 330.581 +0.4375 0.265625 -0.265625 0.4375 0 0.113305 0.100028 1.54853 330.581 0.421875 0.28125 -0.28125 0.421875 0 0.20415 0.0999976 1.59326 330.581 0.4375 0.28125 -0.28125 0.4375 0 0.190041 0.100013 1.61142 330.581 0.375 0.28125 -0.28125 0.375 0 0.167524 0.0999595 1.51876 329.096 -0.390625 0.28125 -0.28125 0.390625 0 0.208371 0.0999978 1.54758 329.096 +0.390625 0.28125 -0.28125 0.390625 0 0.20837 0.0999977 1.54758 329.096 0.375 0.296875 -0.296875 0.375 0 0.274573 0.0998615 1.56766 329.096 0.390625 0.296875 -0.296875 0.390625 0 0.353057 0.100019 1.5995 329.096 -0.390625 0.28125 -0.28125 0.390625 0 0.208371 0.0999978 1.54758 839.04 +0.390625 0.28125 -0.28125 0.390625 0 0.20837 0.0999977 1.54758 839.04 0.40625 0.28125 -0.28125 0.40625 0 0.216713 0.100007 1.57207 839.04 0.390625 0.296875 -0.296875 0.390625 0 0.353057 0.100019 1.5995 839.04 @@ -3827,56 +3806,56 @@ 0.4375 0.3125 -0.3125 0.4375 0 0.457018 0.0999735 1.72294 706.932 -0.4375 0.25 -0.25 0.4375 0 0.0998798 0.0999578 1.49466 1012.24 -0.453125 0.25 -0.25 0.453125 0 0.0995923 0.1 1.5023 1012.24 +0.4375 0.25 -0.25 0.4375 0 0.0998724 0.0999646 1.49472 1012.24 +0.453125 0.25 -0.25 0.453125 0 0.0995925 0.100004 1.50232 1012.24 -0.4375 0.265625 -0.265625 0.4375 0 0.113305 0.100028 1.54852 1012.24 -0.453125 0.265625 -0.265625 0.453125 0 0.111678 0.0999975 1.5575 1012.24 +0.4375 0.265625 -0.265625 0.4375 0 0.113305 0.100028 1.54853 1012.24 +0.453125 0.265625 -0.265625 0.453125 0 0.111678 0.0999978 1.5575 1012.24 -0.453125 0.25 -0.25 0.453125 0 0.0995923 0.1 1.5023 984.021 -0.46875 0.25 -0.25 0.46875 0 0.0999802 0.0999788 1.50508 984.021 +0.453125 0.25 -0.25 0.453125 0 0.0995925 0.100004 1.50232 984.021 +0.46875 0.25 -0.25 0.46875 0 0.0999809 0.0999802 1.50508 984.021 -0.453125 0.265625 -0.265625 0.453125 0 0.111678 0.0999975 1.5575 984.021 +0.453125 0.265625 -0.265625 0.453125 0 0.111678 0.0999978 1.5575 984.021 0.46875 0.265625 -0.265625 0.46875 0 0.109826 0.100007 1.56062 984.021 -0.4375 0.265625 -0.265625 0.4375 0 0.113305 0.100028 1.54852 253.822 -0.453125 0.265625 -0.265625 0.453125 0 0.111678 0.0999975 1.5575 253.822 +0.4375 0.265625 -0.265625 0.4375 0 0.113305 0.100028 1.54853 253.822 +0.453125 0.265625 -0.265625 0.453125 0 0.111678 0.0999978 1.5575 253.822 0.4375 0.28125 -0.28125 0.4375 0 0.190041 0.100013 1.61142 253.822 0.453125 0.28125 -0.28125 0.453125 0 0.182531 0.1 1.61984 253.822 -0.453125 0.265625 -0.265625 0.453125 0 0.111678 0.0999975 1.5575 281.345 +0.453125 0.265625 -0.265625 0.453125 0 0.111678 0.0999978 1.5575 281.345 0.46875 0.265625 -0.265625 0.46875 0 0.109826 0.100007 1.56062 281.345 0.453125 0.28125 -0.28125 0.453125 0 0.182531 0.1 1.61984 281.345 0.46875 0.28125 -0.28125 0.46875 0 0.176653 0.10001 1.62347 281.345 -0.46875 0.25 -0.25 0.46875 0 0.0999802 0.0999788 1.50508 927.711 +0.46875 0.25 -0.25 0.46875 0 0.0999809 0.0999802 1.50508 927.711 0.484375 0.25 -0.25 0.484375 0 0.10007 0.100002 1.50311 927.711 0.46875 0.265625 -0.265625 0.46875 0 0.109826 0.100007 1.56062 927.711 -0.484375 0.265625 -0.265625 0.484375 0 0.108407 0.0999996 1.55853 927.711 +0.484375 0.265625 -0.265625 0.484375 0 0.108407 0.0999998 1.55853 927.711 0.484375 0.25 -0.25 0.484375 0 0.10007 0.100002 1.50311 885.117 -0.5 0.25 -0.25 0.5 0 0.10027 0.0999904 1.49634 885.117 +0.5 0.25 -0.25 0.5 0 0.10027 0.0999906 1.49634 885.117 -0.484375 0.265625 -0.265625 0.484375 0 0.108407 0.0999996 1.55853 885.117 +0.484375 0.265625 -0.265625 0.484375 0 0.108407 0.0999998 1.55853 885.117 0.5 0.265625 -0.265625 0.5 0 0.107014 0.100001 1.551 885.117 0.46875 0.265625 -0.265625 0.46875 0 0.109826 0.100007 1.56062 299.202 -0.484375 0.265625 -0.265625 0.484375 0 0.108407 0.0999996 1.55853 299.202 +0.484375 0.265625 -0.265625 0.484375 0 0.108407 0.0999998 1.55853 299.202 0.46875 0.28125 -0.28125 0.46875 0 0.176653 0.10001 1.62347 299.202 0.484375 0.28125 -0.28125 0.484375 0 0.170735 0.100001 1.62064 299.202 -0.484375 0.265625 -0.265625 0.484375 0 0.108407 0.0999996 1.55853 320.817 +0.484375 0.265625 -0.265625 0.484375 0 0.108407 0.0999998 1.55853 320.817 0.5 0.265625 -0.265625 0.5 0 0.107014 0.100001 1.551 320.817 0.484375 0.28125 -0.28125 0.484375 0 0.170735 0.100001 1.62064 320.817 @@ -3995,10 +3974,10 @@ 0.4375 0.34375 -0.34375 0.4375 0 0.504007 0.0999895 1.82906 215.305 -0.28125 0.375 -0.375 0.28125 0 0.370069 0.0989537 1.4532 175.068 +0.28125 0.375 -0.375 0.28125 0 0.370069 0.0989536 1.4532 175.068 0.296875 0.375 -0.375 0.296875 0 0.479969 0.0999121 1.50947 175.068 -0.28125 0.390625 -0.390625 0.28125 0 0.39718 0.0992321 1.46861 175.068 +0.28125 0.390625 -0.390625 0.28125 0 0.39718 0.099232 1.46861 175.068 0.296875 0.390625 -0.390625 0.296875 0 0.48212 0.0998843 1.52775 175.068 @@ -4009,7 +3988,7 @@ 0.3125 0.390625 -0.390625 0.3125 0 0.502493 0.0996263 1.58258 1521 -0.28125 0.390625 -0.390625 0.28125 0 0.39718 0.0992321 1.46861 280.192 +0.28125 0.390625 -0.390625 0.28125 0 0.39718 0.099232 1.46861 280.192 0.296875 0.390625 -0.390625 0.296875 0 0.48212 0.0998843 1.52775 280.192 0.28125 0.40625 -0.40625 0.28125 0 0.452366 0.0997222 1.47951 280.192 @@ -4034,7 +4013,7 @@ 0.3125 0.40625 -0.40625 0.3125 0 0.496022 0.0998288 1.59602 912.323 0.296875 0.421875 -0.421875 0.296875 0 0.503705 0.0999946 1.54775 912.323 -0.3125 0.421875 -0.421875 0.3125 0 0.497299 0.0999883 1.60411 912.323 +0.3125 0.421875 -0.421875 0.3125 0 0.497299 0.0999884 1.60411 912.323 0.28125 0.421875 -0.421875 0.28125 0 0.50028 0.100006 1.48611 748.928 @@ -4045,7 +4024,7 @@ 0.296875 0.421875 -0.421875 0.296875 0 0.503705 0.0999946 1.54775 1910.9 -0.3125 0.421875 -0.421875 0.3125 0 0.497299 0.0999883 1.60411 1910.9 +0.3125 0.421875 -0.421875 0.3125 0 0.497299 0.0999884 1.60411 1910.9 0.296875 0.4375 -0.4375 0.296875 0 0.510443 0.100004 1.54822 1910.9 0.3125 0.4375 -0.4375 0.3125 0 0.493798 0.100011 1.6064 1910.9 @@ -4110,7 +4089,7 @@ 0.3125 0.40625 -0.40625 0.3125 0 0.496022 0.0998288 1.59602 305.877 0.328125 0.40625 -0.40625 0.328125 0 0.499774 0.0999782 1.65529 305.877 -0.3125 0.421875 -0.421875 0.3125 0 0.497299 0.0999883 1.60411 305.877 +0.3125 0.421875 -0.421875 0.3125 0 0.497299 0.0999884 1.60411 305.877 0.328125 0.421875 -0.421875 0.328125 0 0.500264 0.099994 1.66404 305.877 @@ -4121,7 +4100,7 @@ 0.34375 0.421875 -0.421875 0.34375 0 0.498896 0.0999853 1.72101 280.484 -0.3125 0.421875 -0.421875 0.3125 0 0.497299 0.0999883 1.60411 1006.45 +0.3125 0.421875 -0.421875 0.3125 0 0.497299 0.0999884 1.60411 1006.45 0.328125 0.421875 -0.421875 0.328125 0 0.500264 0.099994 1.66404 1006.45 0.3125 0.4375 -0.4375 0.3125 0 0.493798 0.100011 1.6064 1006.45 @@ -4166,7 +4145,7 @@ 0.28125 0.4375 -0.4375 0.28125 0 0.532004 0.100015 1.48977 1123.36 0.296875 0.4375 -0.4375 0.296875 0 0.510443 0.100004 1.54822 1123.36 -0.28125 0.453125 -0.453125 0.28125 0 0.535645 0.0999788 1.48557 1123.36 +0.28125 0.453125 -0.453125 0.28125 0 0.535645 0.0999787 1.48557 1123.36 0.296875 0.453125 -0.453125 0.296875 0 0.509989 0.0999914 1.54287 1123.36 @@ -4177,7 +4156,7 @@ 0.3125 0.453125 -0.453125 0.3125 0 0.493822 0.0999924 1.60407 2522.63 -0.28125 0.453125 -0.453125 0.28125 0 0.535645 0.0999788 1.48557 763.793 +0.28125 0.453125 -0.453125 0.28125 0 0.535645 0.0999787 1.48557 763.793 0.296875 0.453125 -0.453125 0.296875 0 0.509989 0.0999914 1.54287 763.793 0.28125 0.46875 -0.46875 0.28125 0 0.529307 0.0999889 1.47686 763.793 @@ -4223,24 +4202,24 @@ 0.328125 0.4375 -0.4375 0.328125 0 0.502003 0.100003 1.66639 718.755 0.3125 0.453125 -0.453125 0.3125 0 0.493822 0.0999924 1.60407 718.755 -0.328125 0.453125 -0.453125 0.328125 0 0.502117 0.0999987 1.66337 718.755 +0.328125 0.453125 -0.453125 0.328125 0 0.502117 0.0999986 1.66337 718.755 0.328125 0.4375 -0.4375 0.328125 0 0.502003 0.100003 1.66639 868.702 0.34375 0.4375 -0.4375 0.34375 0 0.496807 0.100007 1.72315 868.702 -0.328125 0.453125 -0.453125 0.328125 0 0.502117 0.0999987 1.66337 868.702 +0.328125 0.453125 -0.453125 0.328125 0 0.502117 0.0999986 1.66337 868.702 0.34375 0.453125 -0.453125 0.34375 0 0.496283 0.0999972 1.71849 868.702 0.3125 0.453125 -0.453125 0.3125 0 0.493822 0.0999924 1.60407 716.199 -0.328125 0.453125 -0.453125 0.328125 0 0.502117 0.0999987 1.66337 716.199 +0.328125 0.453125 -0.453125 0.328125 0 0.502117 0.0999986 1.66337 716.199 0.3125 0.46875 -0.46875 0.3125 0 0.495482 0.0999939 1.59399 716.199 0.328125 0.46875 -0.46875 0.328125 0 0.501811 0.0999977 1.65188 716.199 -0.328125 0.453125 -0.453125 0.328125 0 0.502117 0.0999987 1.66337 800.697 +0.328125 0.453125 -0.453125 0.328125 0 0.502117 0.0999986 1.66337 800.697 0.34375 0.453125 -0.453125 0.34375 0 0.496283 0.0999972 1.71849 800.697 0.328125 0.46875 -0.46875 0.328125 0 0.501811 0.0999977 1.65188 800.697 @@ -4331,24 +4310,24 @@ 0.375 0.5 -0.5 0.375 0 0.497897 0.0999979 1.76352 335.072 -0.5 0.21875 -0.21875 0.5 0 0.0992915 0.0999985 1.38429 237.923 -0.515625 0.21875 -0.21875 0.515625 0 0.0994111 0.1 1.37527 237.923 +0.5 0.21875 -0.21875 0.5 0 0.0992955 0.0999983 1.38429 237.923 +0.515625 0.21875 -0.21875 0.515625 0 0.0994103 0.1 1.37527 237.923 -0.5 0.234375 -0.234375 0.5 0 0.100776 0.09999 1.43758 237.923 +0.5 0.234375 -0.234375 0.5 0 0.100776 0.0999901 1.43758 237.923 0.515625 0.234375 -0.234375 0.515625 0 0.100803 0.100001 1.42752 237.923 -0.515625 0.21875 -0.21875 0.515625 0 0.0994111 0.1 1.37527 237.156 -0.53125 0.21875 -0.21875 0.53125 0 0.0994971 0.0999991 1.36306 237.156 +0.515625 0.21875 -0.21875 0.515625 0 0.0994103 0.1 1.37527 237.156 +0.53125 0.21875 -0.21875 0.53125 0 0.0994979 0.0999991 1.36306 237.156 0.515625 0.234375 -0.234375 0.515625 0 0.100803 0.100001 1.42752 237.156 0.53125 0.234375 -0.234375 0.53125 0 0.100518 0.0999968 1.41369 237.156 -0.5 0.234375 -0.234375 0.5 0 0.100776 0.09999 1.43758 167.179 +0.5 0.234375 -0.234375 0.5 0 0.100776 0.0999901 1.43758 167.179 0.515625 0.234375 -0.234375 0.515625 0 0.100803 0.100001 1.42752 167.179 -0.5 0.25 -0.25 0.5 0 0.10027 0.0999904 1.49634 167.179 +0.5 0.25 -0.25 0.5 0 0.10027 0.0999906 1.49634 167.179 0.515625 0.25 -0.25 0.515625 0 0.100438 0.100001 1.4849 167.179 @@ -4359,15 +4338,15 @@ 0.53125 0.25 -0.25 0.53125 0 0.100504 0.0999965 1.4691 163.527 -0.53125 0.21875 -0.21875 0.53125 0 0.0994971 0.0999991 1.36306 235.677 -0.546875 0.21875 -0.21875 0.546875 0 0.0996403 0.1 1.3475 235.677 +0.53125 0.21875 -0.21875 0.53125 0 0.0994979 0.0999991 1.36306 235.677 +0.546875 0.21875 -0.21875 0.546875 0 0.0996401 0.1 1.3475 235.677 0.53125 0.234375 -0.234375 0.53125 0 0.100518 0.0999968 1.41369 235.677 0.546875 0.234375 -0.234375 0.546875 0 0.100565 0.1 1.39634 235.677 -0.546875 0.21875 -0.21875 0.546875 0 0.0996403 0.1 1.3475 255.932 -0.5625 0.21875 -0.21875 0.5625 0 0.0996861 0.1 1.32872 255.932 +0.546875 0.21875 -0.21875 0.546875 0 0.0996401 0.1 1.3475 255.932 +0.5625 0.21875 -0.21875 0.5625 0 0.0996862 0.1 1.32872 255.932 0.546875 0.234375 -0.234375 0.546875 0 0.100565 0.1 1.39634 255.932 0.5625 0.234375 -0.234375 0.5625 0 0.0999148 0.0999994 1.3758 255.932 @@ -4387,7 +4366,7 @@ 0.5625 0.25 -0.25 0.5625 0 0.101217 0.0999989 1.42491 123.968 -0.5 0.25 -0.25 0.5 0 0.10027 0.0999904 1.49634 841.934 +0.5 0.25 -0.25 0.5 0 0.10027 0.0999906 1.49634 841.934 0.515625 0.25 -0.25 0.515625 0 0.100438 0.100001 1.4849 841.934 0.5 0.265625 -0.265625 0.5 0 0.107014 0.100001 1.551 841.934 diff --git a/tests/refinement_composition_gradient/statistics b/tests/refinement_composition_gradient/statistics index 4bf17b83d94..763d3da8a1e 100644 --- a/tests/refinement_composition_gradient/statistics +++ b/tests/refinement_composition_gradient/statistics @@ -23,5 +23,5 @@ 1 2.209708691208e-02 2.209708691208e-02 304 3114 1379 2758 15 10 13 output-refinement_composition_gradient/solution/solution-00001 6.40229108e-02 1.77256775e-01 5.49634947e-01 3.00116257e-05 6.85572015e-02 1.03779771e+00 1.69278981e-01 1.00001465e+00 1.98954657e+00 1.15609544e+00 2 3.968702553034e-02 1.758993861826e-02 304 3114 1379 2758 16 12 15 output-refinement_composition_gradient/solution/solution-00002 7.38089741e-02 1.77256623e-01 5.40809824e-01 2.74178768e-05 4.70964942e-02 1.05621619e+00 1.69330126e-01 1.00002132e+00 1.98029377e+00 1.15622162e+00 3 5.727696414859e-02 1.758993861826e-02 481 4712 2089 4178 18 13 17 output-refinement_composition_gradient/solution/solution-00003 7.29736797e-02 1.77250413e-01 5.38166898e-01 2.76376180e-05 3.04247050e-02 1.06034316e+00 1.69405237e-01 1.00002860e+00 1.98495303e+00 1.15634005e+00 -4 7.263434206944e-02 1.535737792085e-02 898 8832 3919 7838 30 18 30 output-refinement_composition_gradient/solution/solution-00004 7.52091188e-02 1.77249829e-01 5.35645328e-01 2.70449802e-05 1.98283313e-02 1.05781183e+00 1.69493129e-01 1.00003136e+00 1.98717875e+00 1.15644049e+00 -5 8.000000000000e-02 7.365657930557e-03 898 8832 3919 7838 15 10 14 output-refinement_composition_gradient/solution/solution-00005 7.60780247e-02 1.77249700e-01 5.33745964e-01 2.68146501e-05 1.58592141e-02 1.05526774e+00 1.69542935e-01 1.00000631e+00 1.98708328e+00 1.15648771e+00 +4 7.263434206944e-02 1.535737792085e-02 895 8805 3907 7814 30 18 30 output-refinement_composition_gradient/solution/solution-00004 7.52091188e-02 1.77249825e-01 5.35645328e-01 2.70449792e-05 1.98755515e-02 1.05793429e+00 1.69493274e-01 1.00003136e+00 1.98717875e+00 1.15644049e+00 +5 8.000000000000e-02 7.365657930557e-03 895 8805 3907 7814 15 10 14 output-refinement_composition_gradient/solution/solution-00005 7.60780475e-02 1.77249693e-01 5.33745964e-01 2.68146424e-05 1.59235413e-02 1.05548868e+00 1.69543201e-01 1.00000631e+00 1.98708328e+00 1.15648772e+00 diff --git a/unit_tests/introspection.cc b/unit_tests/introspection.cc index 29c44c37490..f663efe382f 100644 --- a/unit_tests/introspection.cc +++ b/unit_tests/introspection.cc @@ -67,4 +67,12 @@ TEST_CASE("Introspection::1") CHECK(introspection.block_indices.compositional_field_sparsity_pattern[0] == 3); CHECK(introspection.block_indices.compositional_field_sparsity_pattern[1] == 3); CHECK(introspection.block_indices.compositional_field_sparsity_pattern[2] == 3); + + CHECK(introspection.base_elements.velocities == 0); + CHECK(introspection.base_elements.pressure == 1); + CHECK(introspection.base_elements.temperature == 2); + // All compositional fields have the same FE: + CHECK(introspection.base_elements.compositional_fields == std::vector({3,3,3})); + CHECK(introspection.get_composition_base_element_indices() == std::vector({3})); + CHECK(introspection.get_compositional_field_indices_with_base_element(3) == std::vector({0,1,2})); }